Science topic

Mutation Analysis - Science topic

Explore the latest questions and answers in Mutation Analysis, and find Mutation Analysis experts.
Questions related to Mutation Analysis
  • asked a question related to Mutation Analysis
Question
2 answers
Relevant answer
Answer
Please talk about the topics you are familiar with or things which makes sense (recommendation) on this site as this is not a general social media.
  • asked a question related to Mutation Analysis
Question
3 answers
Hi Does anyone know how to format an input file for MEGA X mutation analysis?
Relevant answer
Answer
What multiple sequence alignment format(s) format did you try? Are you sure they were plain ASCII text and not opened with a text editor such as MS-WORD and accidentally saved in WORD (.doc or .docx) format?
  • asked a question related to Mutation Analysis
Question
1 answer
Regarding interpretation of sequence variants using ACMG rules.
Are ACMG rules PS3 and PP3 exclusionary?
In other words, if both PS3 and PP3 rules are fulfilled, can PP3 can be applied?
PS3 - Well-established in vitro or in vivo functional studies supportive of a damaging effect on the gene or gene product.
PP3 - Multiple lines of computational evidence support a deleterious effect on the gene or gene product -conservation, evolutionary, splicing impact, etc.
P.S - For me, they are not exclusionary.
  • asked a question related to Mutation Analysis
Question
8 answers
I'm interested in studying specific missense mutations in a human gene. My goal is to determine whether the mutated region of the protein is conserved across various species. Could you please guide me on how I can use in silico tools to find homologous protein sequences and identify their conserved regions?
Thank you very much
Relevant answer
Answer
That's a good approach Susanta Roy I would add that once you are working with your multiple sequence alignment (MSA) in Jalview (https://www.jalview.org), you load an experimental 3D protein structure, or an AlphaFold model (all possible from Jalview, just right-click on a sequence label), and visualise the mutations and conservation scores on the structure too. Jalview makes this easy by colouring the structure by the sequence, so you can choose to colour by conservation and add features to represent your mutations and they will instantly be viewable on the structure.
The other thing I would add is that in addition to BLASTing the full-length protein, have a look at it on InterPro and see what domains it has. Then you can work with curated MSAs from the individual domains too.
Great question Muhammad Abrar Yousaf !
  • asked a question related to Mutation Analysis
Question
3 answers
Hello All... I am trying to install Gromacs on windows using conda i have attempted to run "conda install -c bioconda gromacs_py" but it's not working. Any recommendations shall be highly appreciated.
Relevant answer
Answer
Ryan Gourlie Sir, I am working with Windows OS and the mentioned one is for Linux and mac. I have also tried this but it's not working. I am working in an environment in conda and I want to install it there. Is there any way I can import it from Cygwin to conda environment or from user apps to conda env?
  • asked a question related to Mutation Analysis
Question
3 answers
Dear all,
I have a problem and I do not know why it is happening. When I do my KRAS mutation analysis most of the samples come out as in the image without the predominant red line. However, some samples, as seen in the other image, show that high thymine contamination.
What I don’t understand is, why that high contamination of thymine only shows up on the KRAS codons. The rest of the sequence is clean and does not shows thymine spikes like that.
Thank you for your help.
Kind regards
Relevant answer
Answer
The broad peak looks like unincorporated dye from the sequencing kit which usually happens when purification of the sequencing reaction is not good. It is worse when there is too little primer or too little pcr product in the sequencing reaction so there is a lot of unused dye to purify away. It usually happens at 2 positions near the start of the sequencing.If you attach one of the .abi sequence files with this problem it would help.
  • asked a question related to Mutation Analysis
Question
5 answers
I am interested in evaluating the role of silent/synonymous mutation using the CRISPR-Cas9. However, I am unable to find any literature related to it. Can you please provide data related to it?
Relevant answer
Answer
Muhammad Abrar Yousaf do you want to completely shutdown the gene or you just want to insert point mutation, in which such gene might/might not be functional?? in case of knockout, CRISPR would be great. However, for silent/synonymous mutation, wouldn't "site directed mutagenesis" work fine? using CRISPR for single base sub, check this papers: https://www.nature.com/articles/s41598-019-41121-4
  • asked a question related to Mutation Analysis
Question
1 answer
How to calculate the ratio of the number of mismatches between reference and reads to the number of all mapped bases at each reference position when I got bam file? Comments on any program or script or any suggestions is welcome.
Relevant answer
Answer
Sorry, I think you have already got your answer. Anyways, for the reference of the other people having similar questions, You can use Integrative Genomic Viewer (https://software.broadinstitute.org/software/igv/) to visualize your BAM file against any reference sequence. After visualization, if you click on any specific point on the coverage plot, it will show you the mutation rate of that particular point of the genome.
  • asked a question related to Mutation Analysis
Question
3 answers
I am trying to generate all possible Associative Fault Mutants for a predicate.
For example: A predicate p= (a*b)*(c*d)
where * represents a logical operator viz., || or &&.
The possible mutants are
m1= a*(b*c)*d
m2= ((a*b)*c)d
m3= a*(b*(c*d))
and so on...
But, when the conditions contains 'Not' operator then what will the possible mutants?
for this predicate p= !(!(!a*b)*c)d, how to generate the possible associative fault mutants?
Any lead will be very helpful.
Relevant answer
Answer
!(...) could be defined a border across which one cannot permutate. E.g. <alpha> * !(<beta>) could permit all variants of <alpha> and all variants of <beta>, but no recombinations of parts of alpha with parts of beta..
Regards,
Joachim
  • asked a question related to Mutation Analysis
Question
6 answers
Hi,
i want to know if i can detect a mutation on a DNA sequence ( Sanger sequencing ) by using BioPython.
I want to know if there is a program to write to detect the position and the type of mutation in the generated sequence compared to a wild type sequence.
Best regards.
Relevant answer
Answer
Every organism is constantly evolving/undergoing mutations to better adapt to it’s environment. Similarly the novel coronavirus will also be undergoing mutations to better adapt to human. It is very important to understand the pattern in which it mutates. Understanding this pattern has significant impact to vaccine/drug development efforts. For example if the Spike protein is undergoing mutation, then the vaccine/drug developed to target the Spike protein may not be effective in all cases. This would mean that we will have to re-start our search for a new drug/vaccine against covid-19 again.
Regards,
Shafagat
  • asked a question related to Mutation Analysis
Question
8 answers
Mutational Analysis.  Will any software help? Could someone help me sort this out?
Relevant answer
Answer
Python can be very useful in getting the result.
  • asked a question related to Mutation Analysis
Question
11 answers
To perform HRM analysis for genotyping on CFX96 machine for the first time, BioRad recommends to use HRM calibration kit along with Precision melt analysis software. I am just wondering whether simply using any good quality DNA binding dye along with standard PCR reagents will work or not?
Relevant answer
Answer
Hi all,
I followed the Lukas Beule logic here:
And made a shiny app with quite a simple GUI for HRM analysis. The app needs no installation and can be accessed via the link:
The GitHub project page is here (the quick guide is in README):
Please feel free to contribute, post any issues and suggestions!
Main app features:
1. Data manipulations (increase the resolution, normalize, trim the temps)
2. HRM analysis (melting curves, difference curves, denaturation curves)
3. Clustering (4 algorithms, 2 modes (on melting temps (Default mode), or on a whole data range (HRM mode)))
4. Find the optimal number of clusters for k-means and hierarchical algorithms
  • asked a question related to Mutation Analysis
Question
6 answers
Overall, the Spanish Flu is likely to be deadliest epidemic in the history of world. Estimates are that 1-3% of the world’s population died from the Spanish Flu. So many younger people died in the US in 1918 that the average US life expectancy was reduced by 10 years.
It is not clear why the second wave of the virus was so much more lethal than the first. There is some speculation that there may have been a mild and deadly version of the virus, but this has not been definitively confirmed. In the ‘developed’ world, the mortality rate was generally believed to be about 2%. In other counties, the mortality rate has been estimated to have caused up 14% of a population (Fiji islands) to die.
Eventually, toward the end of 1918 the number of deaths caused by the virus began to decrease. This is believed to be because there were so many people that had already been infected and/or the virus may have mutated again to be less invasive to the lungs. It eventually ‘devolved’ to be part of the seasonal flu. There was never a vaccine developed for the Spanish Flu.
Relevant answer
Mutation in virus always make it more dangerous as it adopt itself in the environment where it is growing.Duration of the mutation depends upon type of virus.
  • asked a question related to Mutation Analysis
Question
5 answers
The mutations in question are variants of the SARS-CoV-2 reference genome (MN908947.3 NCBI reference) – the first isolate from Wuhan (Wuhan-Hu-1).
Relevant answer
Answer
Nooshin Ghodsian Shirin Parizad Thanks for the recommendations. I appreciate it.
  • asked a question related to Mutation Analysis
Question
5 answers
Different chemical mutagens are available with different modes of action.
Relevant answer
Answer
EMS
  • asked a question related to Mutation Analysis
Question
8 answers
I've bunch of exon variants which lead to non-synonymous mutation. I need some good papers where structural difference due to mutation being analyzed.
Relevant answer
Answer
@ Manoj Kumar Gupta
How to perform simulation for the mutation? Should we first induce the identified mutation (here SNP) into the protein structure and then we simulate that mutant protein using Gromacs in same way as that of "Lysozyme in water" simulation tutorial?
  • asked a question related to Mutation Analysis
Question
34 answers
Novel Coronavirus thought to have transferred to Human from the seafood market in Wuhan, China become a one of the most dangerous viruses in the subfamily Orthocoronavirinae. According to the literature, the genome size of RNA of this viruses are greater than 20 kilobases.
Genetic engineers has committed to change the genes of some organisms to create new features of them, and this can be applied for the Coronavirus as well.
I would like to discuss this matter with Genetic Engineers, Biologist and Scientists.
Relevant answer
Answer
yes but I dont know shift to left or shift to right
  • asked a question related to Mutation Analysis
Question
1 answer
would like to understand the genomic features and structural prediction techniques of rotavirus
  • asked a question related to Mutation Analysis
Question
3 answers
I have found variants in a gene in which I have done in-silico analysis for and it is thought to be disease causing. If I want to study these variants more and see their effect, would it be justified to mimic them on animal model?
there seems to be lack of studies on specific variants or mutations in that gene, but there have been a lot of studies on knockout mouse models that makes it kind of known for us what would happen if the protein has a disfunction or not functioning at all.
So I am thinking, animal model and study the variants? Or to use cells and check if the gene will be dysfunctional and report it that way only ( and then explain what we think the outcome will be based on the status of our subjects who have the mutations and the published papers of the knockout mice)??
Relevant answer
Answer
Hi
If I summarize your question , you mean that you found novel variants in known disease causing genes? If the clinical phenotype of patients is same as that of previous patients with other variants then it can be published and reported as allelic extension. If gene function is well documented then no need to check it on animal model. Just good insilico tools for pathogenecity checking would be ok.
Go for animal models if the gene is novel in implication of a disease and you have multiple patients with similar genetic defect.
Hope it helps
  • asked a question related to Mutation Analysis
Question
7 answers
Hi, I'm working on a variant analysis to detect disease-causing variants in Mucopolysaccharidosis IVA patients. I'm using Sanger sequencing method which includes exonic regions and a minimum of 100 bp intronic sequences from both ends of exons. However, I couldn't find pathogenic variants in several patients. Is it possible if that patients do not have pathogenic variants in exon/splice site despite showing disease characteristics? Thank you
Relevant answer
Answer
Some possibilities are
1 There is another gene that you are not sequencing and this has the changes
2 There are new splice sites being created outside the area that you are sequencing
3 Gene deletions ( or duplications ( large sequence variables)
4 One primer that you are using sits over a polymorphism so there is no pcr product off one allele. The other allele is normal and amplifies and sequences well giving the impression that the patient is normal ( or a carrier if MPS is a recessive)
You could check your sequence for polymorphisms in your sample population if your primer design tool has not already done so
  • asked a question related to Mutation Analysis
Question
5 answers
Preferably, some database that does not take long to respond and whose input is not so complicated. Thanks in advance!
Relevant answer
Thank you all for the answers. I've heard about LOVD: https://www.lovd.nl/
It seems like a good option too.
  • asked a question related to Mutation Analysis
Question
3 answers
I'm working on NrCAM gene mutation. I'm searching to know about any known mutations recorded in NrCAM gene. But I'm not getting any databases or articles regarding that. Can anyone suggest me any mutation database or links to know about the mutations of NrCAM gene in humans.
Relevant answer
Answer
You can use gnomAD (https://gnomad.broadinstitute.org/) to find variants and mutations found in a large dataset of whole exome and whole genome sequencing.
You can search in ClinVar for any variants/mutations with clinical significance (https://www.ncbi.nlm.nih.gov/clinvar/?term=nrcam%5Bgene%5D)
  • asked a question related to Mutation Analysis
Question
4 answers
In my experiment I have checked the bacterial mutation frequency after different treatment. The treated bacteria were spread in a plate containing an antimicrobial. The mutation frequency was calculated as the ratio of grown colony no. and the no. of seeded viable colony (as observed in plate without supplementation). But in case of no growth observed in plate, how to write the result. I have confusion in > or < sign. A result is enclosed for your clarification.
Relevant answer
Answer
The mutation frequency should also be less than <
The problem with the experiment is that you are using too few cells, so if you really want to calculate a mutation frequency you should increase the number of cells at least 10-fold if not more, either on the same plate or use many plates for each condition.
  • asked a question related to Mutation Analysis
Question
3 answers
I've sequenced 4 genes from gene cluster - alcohol dehydrogenase family genes. My problem is with one gene in the middle - the most important for me unfortunately. I use MutationTaster, Condel and PON-P2 softwares for protein function prediction and only with this one I always get problem with transcripts and no results. I have 2 known SNPs within these variants and I checked databases - everything is correct. Where can be the problem?
Kind regards, Paulina
Relevant answer
Answer
Hi Paulina,
I am not sure, if i understand you correctly but still I have few suggestions.
As you know, there are lots of Reference Human Genome Assemblies (from different sources, there are even different releases from Ensembl for the same assembly) and also there are many transcripts (splice variants) for a gene.
Sometimes gene transcripts can also be confusing. (You should use canonical ones.)
In addition to these, you should also be careful about SNP IDs and their origin/release date. (The position might be a bit misleading. Even they have same rs number, their positions could be slightly different.)
So, if you are 100% sure about your gene ID, your transcript ID, your SNP ID (you can also check other HGVS names corresponding to the one you interested), then you can focus on the prediction part.
As it is mentioned on their website (http://www.mutationtaster.org/info/FAQs.html), they exclude protein-coding transcripts without a correct start codon (ATG) and correct stop codon (TGA, TAA, ATG) due to their bad annotation, which might in the end lead to a wrong prediction. This could be one of the reasons.
Also, the type of your SNP (like synonymous/nonsynonymous --> missense and nonsense) may not be suitable for your prediction analysis.
You said your SNPs are known but that can mean many things. If I were you, I would check those SNPs in ClinVar to get any reference paper (and also get info about validation status/ Clinical Significance) so I would have much more information about those SNPs.
For now, that's all I can think of.
Good luck!
Elmas
  • asked a question related to Mutation Analysis
Question
6 answers
CRISPR Cas9 compare to other genomic editing tools
Relevant answer
Answer
Same would be mine comments. CRISPR is easy to use and cheaper.
  • asked a question related to Mutation Analysis
Question
5 answers
hello every one.
I am working on CRISPR/Cas9 and developed transgenic plants for mutation analysis. During tissue culture i can,t get the plants and the callus not going to green and its goes to yellow or black and last its die and cannot regenerate into plants. please give me a valuable suggestion about this. Thanks
Relevant answer
Answer
Hi Mhummed,
To be able to help you to do resolve your problem, I need to know not only which plant you use, but also wich genotype you use on your research? There are many parametrs that may affect the regeneration and regenarion rate depending on the used species based on many years of experience in vitro culture and transgenic plants production of many differents species. In addition to light and tempertaure that you should check, others factors can affect deeply regeneration such as: 1) the genotype, 2)hormones rate (cytok, auxine), 3) Hormone concentrations, 3) sucrose concentration, kinds of vitamins.
  • asked a question related to Mutation Analysis
Question
5 answers
I am currently performing mutation analysis of a gene by Sanger sequencing. I wanted to look for level of deleterious effect of that mutation on the protein.
Relevant answer
Answer
just take a special attention since CADD uses the hg19 genome.
fred
  • asked a question related to Mutation Analysis
Question
10 answers
Hi,
We are trying to do the emulsion PCR for screening of mutant alleles by following the procedure mentioned by Diehl et al (Nat Med. 2008 Sep; 14(9): 985–990) and Dressman et al ( PNAS July 22, 2003 vol. 100 no. 15 8817–8822). We are using Tegosoft DEC, ABIL WE 09 and mineral oil in the ratio of 73%, 7% and 20% respectively as mentioned in the protocol. 600 microL oil was first prepared by following the above ratio and it was layred over 150 microL aquous phase. A 5mm steel bead was added and the mixture was fractionated at 15Hz x 10s and 17Hz x 7s. The emulsion was divided into PCR tubes and PCR reaction was started. Up to this point it was OK but unfortunately the emulsion was breaking after 10-15 cycles. The oil and water phase is getting separated. We are getting cross reaction, may be due to this. We even tried different ratios of the above reagents as mentioned in the original patent. Nothing worked.
I have written to different persons regarding this but didn't get any reply. 
If anybody can help in this matter it will be of great help.
Thanks.
Relevant answer
Answer
Thanks Kim for the update. We are still working on the project. But as I mentioned, the compositions mentions in the papers did not work for us. So we tried different ratios. Try using 1:2 and 1:3 combinations of water and oil.
  • asked a question related to Mutation Analysis
Question
5 answers
Planning to start some transcriptome and mutation analysis and I just need some recommendations on what the best NGS machine/technique for my needs would be.
Relevant answer
Answer
I would again ask to to make a second opinion before going to Ion torrent, and i would recommend you to think about Illumina as an option.
Might this helps you in decision making:
And if you are just thinking about the cost, Oxford nanopore is $1000 for starter kits, which includes device, 2 flowcells and reagents.
  • asked a question related to Mutation Analysis
Question
7 answers
Our research group works with viral detection in human samples through PCR-based methods. We use to sequence the PCR amplicons to confirm the specific amplification of viral sequences in a Sanger-based platform (Applied Biosystems 3500 genetic analyzer). When analyzing the electropherograms generated it is common to observe degenerated bases (usually Ys and Ws) that seems to be not generated by errors in sequencing process, but to rather represent intra-host variability in the viral sequences.
This raised our interest in further investigate these candidate variations and search for possible active mutational processes, specifically we are interested in quantify the possible influence of APOBEC cytidine deaminases in generating these variations (by searching for mutations in APOBEC specific recognition sites, namely 5'-TC-3' over random candidate mutations). Is there any software, package or pipeline adapted for this analysis?
I've read about and downloaded the Minnor Variant Finder software (MVF, from Applied Bisystems), but it seems to be not suited for this question, once it was developed to identify low-frequency human variants and requires the parallel sequencing of a control sequence, which I don't know what could be in my case.
Thank you!
Relevant answer
Answer
Dear Glauco,
Hypermut, as suggested by Brian Foley, is to the best of my knowledge, quite good at estimating APOBEC-driven mutations, although it is more specific to A3G and A3F nucleotide contexts. The algorithm calculates the probability of a given seqeunce to be hypermutated by APOBECs by comparing the unbalance between mutated cytidines at APOBEC versus non-APOBEC (random) contexts, and provides a p-value related to that comparison.
  • asked a question related to Mutation Analysis
Question
12 answers
I know it is possible to identify germline mutations from the blood sample. But, I have serious doubt regarding detecting somatic mutations from the blood sample. 
Generally, somatic mutations are accurately identified using samples from disease-affected tissue region and from a normal region.
Here, I want to know is it possible to detect somatic mutations from the blood sample? If yes, how exactly it is carried out?
Relevant answer
Answer
I believe you must have read a lot of paper about somatic variant calling from blood DNA. It is possible but the accuracy cannot be promised.
Ideally, the alternate allele fraction should be 0% (homozygous) or 50% (heterozygous). If you see 10%, it is possible to be a somatic variant. Again, it needs to be confirmed by Sanger sequencing.
I have doubt about how to define somatic variants as well. I often see variant allele fraction around 30%. I do not know if it can be explained by a somatic variant. I feel the fraction is too high. I would like to know how the other people define them as well.
  • asked a question related to Mutation Analysis
Question
4 answers
Sanger sequencing was used and now next generation sequencing is used for mutation analysis. Can you please guide me about the steps of methodology of next generation sequencing for thalassemia.
Relevant answer
Answer
Hello and sorry for delayed response. it was due to some account issue.
thank you for your concern and replies. I am planning to work on Thalassemia in Balochistan Pakistan. And any kind of educational help is very much welcomed as its a poor province in every aspect. The research facilities and guidance are not enough.
Need guidance and help about the methodology that can be adapted to achieve the goal in low resources.
  • asked a question related to Mutation Analysis
Question
5 answers
Size of genomic DNA is too large with many exons to amplify, so can it be done using a cDNA?
Relevant answer
Answer
Hi Madhubala,
starting from mRNA, yes you can but the risk is to miss some regions and important points, since the cDNA production will not be perfect along the genome (high GC contents for example and poor representation of low expressed genes...). If you plan to analyze NGS, I would advice you to run an exome library preparation to limit your data to exons and splicing events.
fred
  • asked a question related to Mutation Analysis
Question
3 answers
Hello, I just wanted to know if anyone has ever experienced anything like this, where transforming DH5-alpha cells with DNA results in the DNA itself being modified?
I have checked the sequence of my transforming DNA (plasmid is pMSCV, AMPr) and confirmed the presence of my mutations (no signs of a mixed DNA population, the electropherogram is clean).
However after using this DNA (first time by moving the DNA into a clean, new Eppendorf tube, second time by adding competent cells directly to the original tube with the DNA) to transform DH5-alpha cells, I continually somehow get the wild-type version of my gene of interest from kit minipreps. There is no sign of a mixed DNA population, the minipreps yield wild-type DNA with no mutations present.
The competent DH5-alpha cells alone do not contain ampicillin resistance and no colonies formed on my negative control plate. I'm 100% certain I'm using the correct DNA. Not sure how this is possible, but I suspect it's happened previously before with this specific mutation in this specific plasmid (pMSCV), by someone else. There is no -80 degree bacterial glycerol of this mutant (the only one made previously turned out to be wild-type too).  
If anyone has suggestions on what might be happening here, I'd appreciate hearing them.
Relevant answer
Answer
Solved this issue a while ago and thought I'd post the answer. The problem most probably was that the tube had two kinds of DNA (WT and mutant) mixed together to begin with. It wasn't obvious based on sequencing of the DNA initially, but after transforming the same DNA, the new colonies all contained either only WT or a mixture of WT and mutant, according to the electropherograms. 
  • asked a question related to Mutation Analysis
Question
3 answers
Hello everybody,
I have a question to chromatograms.
Is it possible to determine whether a tumor mutation is heterozygous or homozygous when DNA from tumor cells is isolated and amplified by using PCR and sequenced?
I've read that if the mutation is heterozygous a single peak position within a trace may have but two peaks of different colors instead of just one and that this was common when sequencing a PCR product derived from diploid genomic DNA, where polymorphic positions will show both nucleotides simultaneously. (The University of Michigan DNA Sequencing Core Interpretation of Sequencing Chromatograms https://seqcore.brcf.med.umich.edu/sites/default/files/html/interpret.html)
The DNA which is analysed origins from several tumor cells so the chromatogram presents an average of the tumor cells, doesn't it? So how can the chromatogram make a statement about whether the DNA mutation of a single tumor cell is heterozygous or homozygous? It sounds more logical for me that it states that when I have a double peak I can just say that I have DNA strands in the tumor cells that differ from one other and the tumor is heterogenous but how can it be indicative of tumor cells being heterozygous or homozygous? Couldn't it be possible that on the one hand the tumor has cells that have the mutation and on the other hand there are also tumor cells that don't have the mutation?
I'm looking forward for answers and thank you very much.
Relevant answer
Answer
Assuming that you are referring to Sanger sequencing then you are always going to have problems if the template is mixed prior to analysis and generally both of your hypotheses are possible. In some cases it may be possible to be more precise. If in the sequencing you find that there is a nearby polymorphism in your cell line dna then it may be possible to associate the mutation M with one allele of the polymorphism ( let us say that is base A). Then if you ARMS amplify the A allele in your sample and sequence the product then if the product only has the M base then you do not have a mixture of tumour which has both M and non-M ( cloning would also give this information ). NGS would be more informative. In some cases your example would be even more complex as some normal cells will also me mixed in with the tumour cells
  • asked a question related to Mutation Analysis
Question
9 answers
I am working on one gene having 19 exons with 4 transcripts. A deletion mutation (one bace pair deletion) is present in all the four transcripts of this gene. It leads to frameshift and make a stop codon after 6 amino acids. My question is that i have done reverse transcriptase pcr and found no splice variant. After that i did western blot and got the equal amount of protein like in control what could be the possibilities, principally there should not be any protein or if so then it should be significantly reduced?
Relevant answer
Answer
Did you sequence from both sides and are you sure that you are not looking at a sequencing artifact? Can you upload the sequence chromatograms?
  • asked a question related to Mutation Analysis
Question
9 answers
Dear Sir/Madam, 
I am working on DNA sequence (Sanger's method)  to find the SNP's for my Project work. I suspected that one of the mutation is novel, how could I prove that as a novel mutation for publication
what should I do now for confirmation?
Is their any alternative technique for prove?
Shall I go through RFLP? is it enough to prove or else?
Relevant answer
Answer
you  should run normal samples and show that it is not found in about 100 other samples if in the human genome. Also look at the physical properties. Does it change a splice site,cause a stop codon,change a disulphide bond, change properties like small size or polar or aliphatic to large ,non polar or aromatic any of which might change the shape and structure of the dna Consider also if it is in an important part of the protein...a binding domain for other proteins or dimerization region for instance Check also that it does actually cause a change in amino acid.
I do not think that restriction digestion is necessary but sequencing in both directions is the very best evidence for the existence of a sequence
  • asked a question related to Mutation Analysis
Question
4 answers
Hi everyone,
which other prediction tools (in addition to Provean) could be used to predict the Impact of indel mutations?
Thanks for your help! Andreas
Relevant answer
Answer
You can use SNPEff.
SnpEff is a variant annotation and effect prediction tool. It annotates and predicts the effects of variants on genes (such as amino acid changes).
Typical usage :
Input: The inputs are predicted variants (SNPs, insertions, deletions and MNPs). The input file is usually obtained as a result of a sequencing experiment, and it is usually in variant call format (VCF). 
Output: SnpEff analyzes the input variants. It annotates the variants and calculates the effects they produce on known genes (e.g. amino acid changes).
  • asked a question related to Mutation Analysis
Question
4 answers
Hello,
I am looking for mosaics, low level mutations, within human exomes (about 5-10%). Is Next Generation Sequencing able to detect these accurately? I understand this sequencing has a high error rate compared to Sanger but if I am seeing 5-10% mutation of the same base pair is this valid and not just an error? I sequenced entire exomes (using AGRF/Macrogen), getting on average about 100 reads per base pair. Using this data I have found lots of low level mutations and some really interesting results.
Any thoughts/suggestions are much appreciated.
Relevant answer
Answer
Thank you all for your answers! How would whole genome sequencing be advantageous over whole exome sequencing? Are we able to apply the VQSR to our exome sequencing data?
  • asked a question related to Mutation Analysis
Question
3 answers
I am looking for the sequences of p53 pseudo-genes in different mouse species. It is on chromosome 14 (almost certain!) while the true p53 gene is on chromosome 11. Can I specify chromosome number in blast search, so that I only search against chromosome 14? 
Relevant answer
Answer
Matej, Abel, 
Thank you, I'll try those out!
  • asked a question related to Mutation Analysis
Question
4 answers
I am an unexperienced undergraduate working in a lab and am stuck for a long time on this mutagenesis. My PCR reaction is from the protocol from my lab 35 ul water, .5 ul phusion, 1.25 ul of both primers, 50ng of template plasmid, 1ul of dNTPS, and 10 ul of buffer. 
The reaction cycles between 30 seconds at 98C to 3:30 70C ( the plasmid is around 8 kb) for 20 cycles
After that I check to see bands on the gel and they are there usually, but I don't know if they correspond to the new sequence or the old template.
Sometimes I get colonies (I get very few colonies per plate) and I am able to miniprep them and sequence, but the mutation I want is not there when i get the sequence back. Sometimes the DNA concentration is too low to send them out to sequencing. I don't know why. Also, a few times I get a lawn on the LB amp plate which is odd as this may indicate contamination?
Honestly, please tell me what I am doing wrong or any suggestions please.
Relevant answer
Answer
One easy way to distinguish amplification products from the template is to make a control reaction with all the reaction components, but excluding polymerase. Comparing the two reactions on a gel will let you know whether the amplification was successful or not. Strong amplification usually results in more colonies, and also a higher frequency of mutated DNA. Sometimes mutated plasmid can arise from non-visible amplifications, but the success rate tends to be lower.
I agree with the idea that primer design is directly related to amplification efficiency. Particularly, primer ends rich in AT sequences must be avoided. I normally use primers covering 15 nt before and 15 nt after the region to be changed, but if amplification is not ok strong, I extend the annealing length.
 I don't know why you are using cycles between 98 and 70C. What I normally do is to perform denaturation at 98C, annealing at 50-55C for 30 sec, and then extension at 72C. this should guarantee proper annealing.
You didn't mention DpNI digestion of amplification products before E.coli transformation. Are you doing that? This step would remove DNA template, increasing the efficiency of the overall  procedure. If you include this step, do  exactly the same to the control reaction. You should get less colonies from the control reaction without polymerase than from your amplification reaction. And don't forget to include a transformation negative control (competent E.coli submitted to heat shock in the absence of DNA) to exclude contaminations during this step.
If you still get a few colonies by heat shock transformation, particularly when the amplification bands are rather weak, electroporation should result in more colonies to be tested, increasing the chances of getting mutated plasmid. 
  • asked a question related to Mutation Analysis
Question
6 answers
Hi,
Imagine you got a mutant library of a plasmid DNA generated by random mutagenesis and affecting the whole plasmid sequence. This mutant library is going to be used to transform bacteria and check which mutations are selected.
Can you approximately estimate the probability of having deleterious mutations in known plasmid genes. For instance, what's the probability of obtaining a mutation that disable the antibiotic resistance gene? 
many thanks
Relevant answer
 Thank you very much!!
  • asked a question related to Mutation Analysis
Question
3 answers
I check the mutation frequency of several tumor driver genes on COSMIC
For instance, there are two data.
Total number of unique samples: 42439
Unique samples with mutations: 797
I would like to ask whether these mutations are heterozygous or loss of heterozygosity or sum of both cases. I think it might make a great difference for tumor repressor genes.
Relevant answer
  • asked a question related to Mutation Analysis
Question
1 answer
I am looking for designing crRNA against the putative G-quadruplex forming motifs. Taking account of the criteria for a good crRNA, web-based design gives crRNA sequences that don't overlap the sequence of my interest. On the contrary, manual design compromises the quality of the crRNA with lots of off-targets in the genome. However, this is very difficult in designing any primer against the sequence having tandem guanine repeats. 
Therefore, I have planned to design two crRNAs in (+) and (-) strands respective having 84 bases in between and want to ensure the deletion of the 84 bases in between by CRISPR-Cas9 method. My design of crRNA is provided in the attachment. Please help me in in this regard.
Relevant answer
Answer
Sorry I could not help because it is not my interest
  • asked a question related to Mutation Analysis
Question
12 answers
We are planning to do mutational analysis using Droplet Digital PCR and Cast PCR, can anybody suggest the best extraction methods for low ctcs (5-2000) cells? 
Relevant answer
Answer
I think you can use column based commercially available kits.
  • asked a question related to Mutation Analysis
Question
5 answers
Under the assumption that sites under positive selection are more tolerant to mutations, can one interpret (assume) the intolerant sites to not be under positive selection?
Relevant answer
Answer
No. Here's why: The way the question is framed conflates (mixes together) two different types of mutations that have different consequences. Point mutations change a base that changes an amino acid and may lead to a protein with an altered function. Insertional mutagenesis typically makes a null allele of the gene into which the insertion is done. In the insertional case (as it is typically done in screens) the gene is "knocked out".  The insertion allele is the phenotypic equivalent of a full deletion allele. 
Your way of thinking about it is very original. Genetics is a vast field and I would not be surprised if there are specific cases that match your idea but they will be rare.
  • asked a question related to Mutation Analysis
Question
5 answers
the genes X and Y both a phenotype when mutated individually while keeping the other one unmutated but in case of a double het KO of X & Y i see a less severe phenotype than expected. why? 
Relevant answer
Answer
You need to clarify your terminology and specify when a mutation is homozygous or heterozygous.
This sort of observation is common when X and Y are in the same pathway.  
  • asked a question related to Mutation Analysis
Question
7 answers
I'm getting frame shift mutation in one of my mutation. I'm using wild type as template and using forward and reverse primer. Then doing dpn1 digestion. And then transformation and send for sequencing. But every time I'm seeing that mutation happens at a particular place I'm looking for , but frame shift mutation happens also. Please suggest a way of avoiding frame shift to happen
Relevant answer
Answer
From what you say It seems that your primers are degradated or not synthetized correctly.... maybe you can re-order them
  • asked a question related to Mutation Analysis
Question
4 answers
i have to identify the number of pseudo gene present in genome, what are the methods by which i can predict and identify these pseudo sequences. Please suggest me any online or offline tool or software for this query.
Relevant answer
Answer
Thank you Mr Tanuj Sharma
Mr Scott Helms i am looking for method as well as tool if it is present there.
  • asked a question related to Mutation Analysis
Question
8 answers
There are a lot of articles talking about genetic variant and more talking about mutations. At this stage if we have a clear cut definition which could clearly differentiate the variant and mutations?
Relevant answer
Answer
We have had this question before and it generated a lot of discussion and even some contentious disagreement.  Some folks raised the allele frequency as evidence of a variant rather than a mutant.  A variant might be 1% or more in the population.  Others used a functional definition for mutation as any DNA replication error.  I think there is no clear answer because the language is imprecise.  Mutations were originally defined as heritable changes in phenotype, long before we even knew what DNA was.  Variants typically arose as mutations and spread into the population.  In the end, they are both differences in the DNA sequence.  
  • asked a question related to Mutation Analysis
Question
9 answers
How  gene polymorphism is different from gene mutation?  all gene polymorphisms contribute to disease susceptibility?
Relevant answer
Answer
Karki et al (BMC Med Genomics - 2015) report these definitions:
  • mutation: DNA variant present in < 1% of the population;
  • SNP: DNA variant present ≥ 1% of the population.
Therefore, according to the population selected, a variant could be a SNP or a mutation. And a homozygous SNP could also be disease-causing.
They propose that a mutation should be defined as "result of a recent mutation event which has been detected using as a reference the germline DNA of the same individual". In the paper you can find further discussion about the nomenclature.
  • asked a question related to Mutation Analysis
Question
6 answers
Braf exon 15 is about 220bp. After amplification the bands were proper but faint. The problem occured only during re amplification and that too only in few samples.But the reamplification of other genes on the same samples gave proper results.
2% agarose gel was used.
Relevant answer
Answer
The samples used are FFPE samples. So, I was wondering if it would be safe to proceed with PCR purification for the products of first amplification instead of the usual re-amplified products? Or should I go for re-amplification with changes in the cycle number?
  • asked a question related to Mutation Analysis
Question
4 answers
I intend to edit those genes using CRISPR /Cas9 tool 
Relevant answer
Answer
Hi Abass,
there's a lovely review by my supervisor that lists (non-exhaustively) 36+55 genes known to be involved in learning and memory in Drosophila. Here's part of that list taken from Keene and Waddell, 2007, NatRevNeuro:
amnesiac dunce rutabaga turnip radish DC0 PKA-RI G-s60A Neurofibromin leonardo volado (scab) fasciclin II damb dDA1/DMDOP1 oamb mushroom body miniature mushroom bodies deranged ignorant (S6KII) latheo nalyot (Adf1) linotte (derailed) milord (pumilio) norka (oskar) krasavietz (eIF-5C) staufen armitage Nmdar1 Nmdar2 dCREB2 (CrebB-17A) nebula (sarah) Tbh Notch crammer aPKC tequila synapsin
The 55 more refer to this relatively recent mutant screen from 2003 that looked specifically at long-term memory: http://www.sciencedirect.com/science/article/pii/S0960982203000642
There are surely more genes, many of which have been discovered since that review appeared. There have been many learning mutant screens since the 70s pioneered by Tully and Quinn from Seymour Benzer's lab (dunce was the first one in 1976), and the field has widely moved from the question of identifying genes to identifying the neurons in which these genes are expressed, what they do there, and how these neurons interact with one another in the brain. So as you see, your question has been largely answered already, and it might make sense to rather work with the genes that have already been uncovered rather than re-inventing the wheel. On the other hand, mutants in the past have mostly been generated by random mutations, and they may thus be not as 'clean' as the CRISPR technology would allow, so there's a chance for some false positives in the previous datasets that you could uncover.
In any case, hope this helps.
Cheers,
Oliver
  • asked a question related to Mutation Analysis
Question
2 answers
Pardon my ignorance, but there are a number of papers discussing amino acids in DHFR that seem to be "off by 1". i.e. Leu22 when it is Leu23, Cys 6 when it is Cys 7, Phe30 when it is 31. It seems that those in the DHFR field are ignoring methionine 1. Is that the case? And if so, why?
Relevant answer
Answer
According to UniProt http://www.uniprot.org/uniprot/P00375, the initiator Met in murine DHFR is removed. So some people orient themselves on the gene sequence, others on the mature protein sequence when numbering the residues. Might be one of those proteins that was first sequenced as protein, and an old numbering scheme based on the amino acid sequence has not been fully superseded by numbering based on the ORF.
  • asked a question related to Mutation Analysis
Question
6 answers
We are studying a gene with 5 exons. In a patient with a mutation in one of the introns we detect a splicing defect such that exon 3 is missing (exons 1,2,4,5). Yet we also detect the wild type variant containing exon 3 (exons 1,2,3,4,5). I can design an oligo that spans the exon 2,4 junction to measure specifically the variant that lacks exon 3. But if I want to compare the relative levels of the two variants in the same cell by qPCR, how would I do that? Oligos that anneal to all other exons will be in common between the two variants.
Relevant answer
Answer
I'm thinking the melting curve might be the way to go. The two species should be different enough such that they have different melting curves. But again that only measures the endpoint, not during log phase amplification, so it may not be quantitative.
  • asked a question related to Mutation Analysis
Question
3 answers
I have a plasmid which differs by one base from wild type. This base will change the protein by one amino acid, hence I need to mutate that base which is residing in the central part of the plasmid. Is inverse PCR the only option for it? 
Now about designing the primer for inverse PCR- 1) Where should I put the mutated base - terminal or central position of the primer?
2) Should I put the mutated base in both forward and reverse primers or either of them?
Please illustrate with an example if possible.
Thanks
Relevant answer
Answer
Hi Dr Rajdeep,
Please use Q5 SDM kit from NEB. You should design primers using below tool http://nebasechanger.neb.com/
This is very much accurate and easy tool as well as method. I have done more than 10 such successful mutagenesis clones using this
  • asked a question related to Mutation Analysis
Question
8 answers
Following CRISPR mutagenesis and sequencing analysis of the F1s, I have found a heterozygous male with 10bp deleted on exon1 and a heterozygous female with 5bp deleted on exon 1. I was wondering if there is specific term that would be applied to F2 offspring that would inherit both these mutations, because this is not homozygosity. Thank you.
Relevant answer
Answer
yes that is ok you can have alleles with insertions, deletions, point mutations or any change really  but heterozygous is a general term that can be used to describe any 2 (or more if appropriate species) different alleles even if one allele were completely deleted in which case you could be heterozygous for normal/null alleles
  • asked a question related to Mutation Analysis
Question
2 answers
I am trying to study the effect of mutating or deleting different TFBS (one at a time)in the promoter region of a gene of my interest(a mouse gene),by cloning promoters containing the mutated sites in a pGL3 basic vector and then transfect HEK293 cells with them,i wanted to know about:
1. how should i design the primers in order to either mutate or delete the TFBS in the promoter.
2. what measures should i take in order to avoid any interference from the endogenously expressed TFs in the cell line.
Relevant answer
Answer
Hi
to analyze the TFBS mutation, you have two solutions, analyzing your gene of interest and see in arrays data the results (cost++) or a reporter gene to run luciferase essays (faster and less expensive). take a look at the wikipedia page to get more details (https://en.wikipedia.org/wiki/Site-directed_mutagenesis).
fred
  • asked a question related to Mutation Analysis
Question
2 answers
Your work refers to rare mutation R360T in gene KCNQ1 however only very briefly, can you recommend any publications or information source on this particular mutation?
Relevant answer
Answer
thank you, that is indeed very helpful
  • asked a question related to Mutation Analysis
Question
3 answers
would you please advise me of the best molecular technique for mutation detection in CYP21A2 
Relevant answer
Answer
Nothing beats PCR and DNA sequencing if the region of interest is small. If gene is too large , start with RNA, make cDNA and sequence - you might miss some mutations in intron/exon junction and promoter - but you'll get all the coding ones
  • asked a question related to Mutation Analysis
Question
5 answers
Please, I need some advice.
How to make a deletion in the middle of the gene?.
Relevant answer
Answer
 Chemical synthesis with defined deletion is the most reliable method. The synthesis is affordable these days.
Pick two conveniently located, ideally unique, restriction sites flanking the target deletion region, get the piece of DNA extending slightly beyond restriction sites on both sides synthesized, cut the synthetic DNA with restriction enzymes and ligate into the cloned gene with the wild version od the same region removed. 
  • asked a question related to Mutation Analysis
Question
4 answers
Has anybody – apart from the information provided in the original and other papers and the information available from DSMZ, Cellosaurus, Cosmic and similar sources – genetically characterized the LAZ-221 cell line in more detail in terms of fusion genes, copy number alterations, mutations, indels,… by RNA-seq, WES, or WGS and would be willing to share this information?
Thanks in advance!
Relevant answer
Answer
Thanks for sharing this information, which is basically what we found out. We have ordered the cell line from DSMZ and as soon as we have stocked up some vials, will characterize it on our own, starting with some FISH and a SNP array analysis.
  • asked a question related to Mutation Analysis
Question
3 answers
The original approach from the Jaenisch lab uses two ssoligos and 2 guide RNAs.  We were lucky to have obtained one (out of 40 genotyped) mice, though a single base pair deletion outside the CRE binding site was evident; this however did not affect cleavage.  I am polling the globe to see who has had success in mice with the original method and if not, which method are you following?
Thanks all
Joe
Relevant answer
Answer
Thank you Jetty. I am familiar with all of thee papers; I am looking for anecdotal experiences with making cKO using CRISPR that have not been published.
  • asked a question related to Mutation Analysis
Question
3 answers
We want to detect low abundance of mutations and differentiated expression of genes in tissue samples. We suppose that some mutations and differentiated expression of genes in the cancer cells, but not in the stromal cells. Whole sample DNA or RNA extrations may lead to artificial results, some times false negative and some times false positive. We try laser micro-dissection of the fresh samples to dissect the cancer tissue, but due to the low concentration of the DNA or RNA after extration, analysis can not be conducted. 
Relevant answer
Answer
Hi Huiyi,
the key point in your study will be the amount of cells you're starting with. since 1ng of DNA means around 150 cells, no need to get a deep sequencing if you just have poor quantities of material.
fred
  • asked a question related to Mutation Analysis
Question
4 answers
I am planning some experiments to determine the effect of a drug on zebrafish adults carrying a mutation of my interest. My strategy is to use a tank of F1s to obtain F2s, genotype them and then segregate them as hets, homs and wild type as I want to check whether different groups react differently. The problem though is that my first batch of F2s has yielded very few homs and wild types. So I am now raising a second batch of F2s from the same F1s. I could perform the same experiment individually on each batch or combine the two batches and do the experiment once. Statistically, I could obtain large variation between the few homs, for example, and this could be mitigated by having larger nos. of homs. However, I am also concerned about variations between different F2 batches. Any advice would be greatly helpful.
Relevant answer
Answer
Thank you for your insight :) We cut a very tiny bit of the fish's tail fin and extract genomic DNA from this clip. Then, we amplify the area of interest using PCR and use another primer for sanger sequencing of the PCR product. The sequence for hets will reveal two overlapping peaks while homs and WTs will show single peaks :)
  • asked a question related to Mutation Analysis
Question
1 answer
What we know about cysteine is that oxidized during the time? So, if it's the case, do you have any idea how stable cysteine mutant? I have already tried to incubate my protein sample into 1% DTT for 30 min at pH 7.5(if there is any oxidation). And I observed some differences, however, I have some doubt about the effect of DTT on my sample. Do you think the best thing to answer this question is mass spectroscopy or there is another way that ı could try and see?
Relevant answer
Answer
Mass spectroscopy would be a good way to tell if the mass of the protein changed due to oxidation of the cysteine thiol. Another way to tell if the cysteine is in the thiol form is to test for its reactivity with a thiol-reactive probe. For example, after removing the DTT (or using TCEP instead, which wouldn't have to be removed), you could react the protein with fluorescein maleimide, which will react with thiol only. After removing the excess label, you could then tell if the protein became fluorescent. By measuring the stoichiometry of labeling, you could determine what proportion of the protein was in the thiol form during the reaction.
  • asked a question related to Mutation Analysis
Question
4 answers
hello
I am working on subcloning to insert my target protein to new vector, after the restriction, ligation,and transformation I did sequencing for the DNA by the vector primers VP1.5 nad XL39 and the result was fine the protein is inserted but there is stop codon between the protein coding sequence and the tag need to be removed. I used the site directed mutagenesis kit  to remove the stop codon then the product was transformed and sequenced again 
the XL39 primer sequence showed the stop codon was removed because it is close to the mutation site but the VP1.5 primer sequence failed (no reading at all with big blob) for all the 5 colonies that picked 
the cycling parameters as the kit protocol suggests; 25 Cycles, Initial denaturation 98 °C 30 seconds, 98 °C 10 sec, annealing 63 °C ­30 sec, 72 °C ­30 seconds/kb -the vector size is 6200 b so I extend for 4 min- Final Extension 72 °C 2 minutes
Is there any explanation for this?
Relevant answer
Answer
just getting a blob suggests that the primer is not annealing so either its sequence does not exist exactly or the annealing temperature is too high. As another primer has not worked you could just try a much lower annealing temperature ( the target size is small so there is probably nowhere else to anneal) or if you think that tertiary structural problems are to blame then sequence in the presence of 1M betaine and then very thoroughly desalt before loading on the capillary. If you posted the original .abi file there is often embedded information which might help
  • asked a question related to Mutation Analysis
Question
6 answers
I know in theory that it's possible for a non-synonymous AA substitution to have little functional effect, but can anyone provide a real-life example? I can find papers where mutations predicted to have an effect on function were then tested and found to indeed affect function, but have not found any reports of a tested substitution that was found to be functionally neutral.
Relevant answer
Answer
There are examples in medical case-studies of the type "We found three patient mutants, and this one 1 is the one that actually does anything". In such cases positive and negative results are in the same paper.
  • asked a question related to Mutation Analysis
Question
3 answers
we identified multiple mutations (vus) in human genes that we believe have a protecting effect against cancer.
is there any database or web tool that can be used to detect the function (and generate survival curves) of VUS in cancer patients? for example by generate survival curves of people harboring the mutation?
Relevant answer
Answer
Thank you  Frederic Lepretre and Peter Ulz for the answers !!
we are still try to figure out how to handle all the predictions we have
  • asked a question related to Mutation Analysis
Question
1 answer
Dear friends
I am trying to construct few deletion mutants of Mycobacterium abscessus using the pJV53 recombineering system. I have transformed the M. abscessus cells harboring the pJV53 plasmid (carries recombinase, Km resistant) with the linear PCR product which contains the flanking regions of the gene to be deleted and the zeocin cassette. I selected the colonies in 7H10 plates containing kanamycin and zeocin. However, when I do PCR to confirm the incorporation of zeocin cassette into the gene to be deleted, I get the same band as that of wild-type. I checked the resistance of M. abscessus WT cells to kanamycin and zeocin and the cells didn’t grow in both the antibiotics.
Any help on this would be greatly appreciated.
Warm regards
Bindu
Relevant answer
Answer
Double check all your original DNA sequencing -sounds like there is a STOP codon that needs  to be eliminated...
  • asked a question related to Mutation Analysis
Question
1 answer
Hello all,
1. Is there anything database that helps in the identification of tumour types and relevant cell-lines where CCDN3 mutations are observed? I‘m interested in the CCND3 mutations that accrue around the phosphorylation motif at amino acid T283.
2. We have a drug that causes CCND3 degradation in cell lines. Is there any experiment to confirm our findings? Eg: looking further at expression level of genes that are activated by CCND3?
Thanks
Lax
Relevant answer
Answer
In Cosmic you will find a comprehensive overview of somatic mutations that have been observed in CCND3:
You can then query each mutation and see in which "sample" it has been found. There does not seem to be any mutation reported in T283, but there are some in the neighborood. For example P284S:
Here you can click on the sample links:
In that example, you have 4 different samples with this mutation and you can see in which type of cancers they were observed. Only one sample is "cultured" (ie a cell line), it is NU-DHL-1:
Here if you want more knowledge on what this cell line is you better go out of Cosmic and go to our Cellosaurus (there is no direct link in that direction), So just do a search of the sampleID or the name and you will find:
You could automatize the whole process of retrieving all cell line samples with mutations in CCDN3 in Cosmic using their "Cosmic MART" application, but if you are only interested in mutations in the vicinity of T283, it will be much faster to go through the steps described above manually as there is only a limited number of mutations described in that gene. 
  • asked a question related to Mutation Analysis
Question
3 answers
A female patient presented with bilateral lower limb weakness for 10 years and bilateral upper limb weakness for 4 years. CAEab(+), AchRab(+). EMG suggests muscular impairment. No decremental EMG response of the compound muscle action potential (CMAP) was detected on low-frequency (2-3 Hz) stimulation. She had mutations in gene AGRN(c.2255-3insA) and gene MATR3(c.1778+3A>G).No family history. Her sister and her mother had the same mutation in AGRN. Her father ha the same mutation in MATR3. Is it possible to be digenic inheritance pattern? MATR3 may interfere with splicing site of AGRN.
Relevant answer
Answer
yes it is possible ,but very rare 
  • asked a question related to Mutation Analysis
Question
2 answers
I want to perform site directed mutagenesis to a sequence I have cloned into a pGL4.1 vector, but I'm not sure which vector to clone the mutants in once mutagenesis is validated. I want to clone into LNCaP cells (prostate cancer cells) and perform ChIP and qPCR analysis for target genes. I am a first year graduate student and not sure how to go about deciding.
Relevant answer
Answer
Hi Ariel,
I don't know the answer to your question, but I'd like to try and help you in a different way. As a first year graduate student you are probably going through your rotations and you should be able to ask this question to your mentor or to more senior graduate students or postdocs in the lab; I would start asking any of these people, they are likely to know the project and should be in the position to help you out. If no one in the lab is able or willing to help you, I suggest you look for a different lab and make sure you find a friendly and collaborative environment.
Good luck!
  • asked a question related to Mutation Analysis
Question
2 answers
Needed for divergence and demographic expansion study.
Relevant answer
Answer
Excellent, thank you!
  • asked a question related to Mutation Analysis
Question
2 answers
I need to locate the mutation in the gene. I know the amino acid, the position number and the aminoacid I need to change it to. But how do I locate it in the gene?
Thanks,
Ariadna
Relevant answer
Answer
hello you can go to http://www.bioinformatics.org/sms2/rev_trans.html reverse translate it to nucleiotide sequence and blast it in to NCBI I hope you will get the appropriate gene sequence with single nucleotide mutation.
all the best
  • asked a question related to Mutation Analysis
Question
2 answers
I have a metabolic phenotype due to some unknown mutation. what are they ways to identify the location and mutation on genome except whole genome sequencing?
Relevant answer
Answer
This may be too wide a question to get an answer to, so perhaps you can narrow it down. It really depends on what kinds of data you have and/or can generate. For example, depending on what data you have, you may be able to calculate how frequently the phenotype is inherited along with other traits that you do know the location of, and thus map the gene based on linkage, using classic genetics.
  • asked a question related to Mutation Analysis
Question
6 answers
I need an online tool that would calculate all possible neutral mutations in a certain reading frame of a protein-coding sequence and provide me with a list of restriction sites that can be created by introducing neutral mutations. Do you know such tool? Thank you.
Relevant answer
Answer
Hi Dmitriy,
It will return a list of all possible mutation in a given sequence. However, you can only input sequences up to 100bp.
In short, you need to:
1) input a sequence (oligo sequence)
2) choose a reading frame
3) sort the results by cleavage site
4) you have the list of all the possible mutations and novel restriction sites (underlined in the sequence). 
Nicolas
  • asked a question related to Mutation Analysis
Question
6 answers
Hi,
I am the graduate student of bioinformatics
I got whole genome sequence through next generation sequencing and have been doing comparative analysis using it.
And I need to find the mutation rate (or change rate) from previous reported sequence because they are looked really similar but not matched perfectly. . However I can't find the way to figure that rate
I have searched for many many days through NCBI or google scholar
but I cant find anything :(
Is there a previous report or something way to solve it?
Relevant answer
Answer
Unless you know the date that the two genomes shared a common ancestor, you cannot calculate the rate of change over time.  For an example, we have complete genomes of several Neanderthal individuals, one Denisova man and a few thousand modern human individuals, but we do not know the exact date that modern humans diverged from Neanderthals, and in fact many groups of modern humans appear to have shared alleles with Neanderthals quite some time after the two groups seem to have split from a common ancestor.  Both incomplete lineage sorting and admixing after separation can cause genes to have different histories than species.  
In the bacterial world, an example is that the E. coli carrying a Shigella toxin gene (STEC) that killed people in Europe in the summer of 2011 was quite highly related to a strain of E. coli that had killed people in the Middle East in 2008, but there is no reason the believe that the x numbers of mutations observed between those two genomes accumulated in 3 years.  The common ancestor of the two isolates may have lived 5 or 50 or 500 years ago. 
We do know rates of evolution from many data sets where the date of a common ancestor is known with some precision relative to the genetic distances involved, and it is more common to be able to estimate the dates of common ancestors from sequence changes, than it is to be able to measure the rate from a known date of common ancestry.
For many RNA viruses we can see the rate of evolution from samples taken less than 10 years apart where we know for sure the dates of common ancestry.  But viruses with RNA genomes can evolve close to ten million fold faster than eukaryotes and a million fold faster than bacterial genome DNA.   The E. coli Long-term Experimental Evolution Project Site has some good data for one example of bacteria.
  • asked a question related to Mutation Analysis
Question
1 answer
Respected all,
Our research group have conducted some study related to behavioral genetics, we are working on a microsatellite repeat in promoter region of a gene. Can we predict insilico, that variations in repeat element can effect transcription etc. If yes then what toolshould are method we can used for it? Is there any related article to this specific study ?
HOPE to see best response from researcher's 
Relevant answer
Answer
What type of repeat is that? A trinucleotide maybe? If yes, let me know (email is best), I am working on an answer and I may be able to help you.
 I do not know of any standard tools, but we are working on one.
  • asked a question related to Mutation Analysis
Question
3 answers
Portulaca oleracea is a medicinal plant.is there any experience on mutation breeding of this plant using physical and or chemical mutagenesis?
Relevant answer
Answer
You can refer my papers for in vitro mutagenesis. The protocol can be used for other crop or medicinal plants also.
Best Wishes,
A. Muthusamy.
  • asked a question related to Mutation Analysis
Question
3 answers
Dear all,
I try to detect possible mutations within my DNA.
For this, I use the Surveyor Nuclease S Assay (Cel-I-Assay).
After heteroduplex Formation andTreatment with Surveyor Nuclease, I don´t get any product.
Strangely, I checked my DNA after PCR purification via gel electrophoresis and detected a clear and distinct band, as expected.
So, what happended to my DNA? Any suggestions?
Best regards
Relevant answer
Answer
Hi Bastian,
I am assuming that you have an uncut heteroduplex band in your nuclease gel track. The 2 most likely reasons are  that the heteroduplex is , in fact , a homoduplex so cannot cut. This will happen if there are no mutations/snps. Alternatively if you have normal template contamination in your pcr mix then what you expect to be mutated pcr product is,in fact, normal. What do the negative controls of you PCR look like?
I am attaching an iDT guide to surveyor just in case there is something useful concerning the surveyor buffer and various pcr buffers ( page 22) which may be of interest.regards
paul
  • asked a question related to Mutation Analysis
Question
1 answer
I am mutating 3 amino acids, or 9 nucleotides. I need to cover all combinations. If I put N on all positions, is that good or somebody has better idea, I am happy to hear it. Thanks.
Relevant answer
Answer
Yes, you can achieve that by adding N in all nine positions to fully degenerate your mutagenesis primers. You might find that some mutations appear more frequently than the others since some nucleotides seem more preferential during the oligo synthesis although without any clear explainable reason, you will get all the mutations by isolating more clones. Since you need a large number of clones to cover all the mutations, an efficient site-directed mutagenesis protocol like that described  http://bmcbiotechnol.biomedcentral.com/articles/10.1186/1472-6750-8-91will help a lots.
  • asked a question related to Mutation Analysis
Question
2 answers
Is it possible to have spontaneous Loxp recombination in the absence of Cre recombinase? If so, are there any citations available?
Relevant answer
Answer
It may happen as a rare event in a single cell. You will not notice it unless the cell that recombined out your construct has a selective advantage (proliferates better). In the latter case, you may detect spontaneous LoxP recombination over time.
unaware about the references.
  • asked a question related to Mutation Analysis
Question
4 answers
I was hoping to use the Surveyor assay from IDT to detect large (~600bp) deletions in a gene of interest. The wt amplicon should be ~1.2kb. My main questions are:
1) Is it even likely that the wt and mutated fragments will anneal?
2) If so, will the Surveyor nuclease recognize the sizable mismatch
and finally
3) If a mismatch is detected by the enzyme, where should I expect it to cut? At the start/end of the mismatch region? In the center? IDT doesn't offer much on this subject.
Any information would be greatly appreciated!
Relevant answer
Answer
Oh ok, I guess I see your problem, thanks Rogan.  It still seems to me that if you have a large indel you can detect it just by PCR. If the indel is small Surveyor will detect, but I think the results may be messy if the indel is over 20bp or so. Others may have more experience with this...
  • asked a question related to Mutation Analysis
Question
10 answers
Exome data obtained from NGS analysis show the mutation in PMS_2 gene. I  would like to confirm the mutation by Sanger sequencing but the PMS2 have a Pseudogene PMS2CL. I'm trying to isolate the sequence by LR-PCR and then  nested PCR but I can not confirm the mutation because I supposed that my primers annealing with the sequence of PMS2 pseudogene. 
Relevant answer
Answer
You can use gDNA and choose one longrange PCR primer in the unique exon 6, or you can use cDNA but you should use RNA from shortcultured lymphocytes or fibroblasts in which you can inhibit nonsense mediated decay. For PCR of cDNA you should also use an amplicon with at least one primer in a unique PMS2 exon (exons 6-8 and 10).
  • asked a question related to Mutation Analysis
Question
16 answers
I found a new variant (a substitution) in exon 20 of BRCA1 gene. This is not reported in HGVS, BIC or any other mutation database. The variant was found after sequencing with both the forward and reverse primer in case of  only one patient. How can I proved that it was not a polymorphism but a mutation? Plz suggest.
Relevant answer
Answer
Hi Abhijit,
A 'polymorphism' is normally defined as a variant found in >1% of the population, (the exact percentage used by different people can vary). However, it usually means a fairly common benign variant.
The best resources to check to see if your variant is common, rare, or novel are
A 'mutation' is normally defined as a variant that has a pathogenic effect. These are normally very rare or novel, but can also be common. There are many computational tools which can predict the possible pathogenicity of a nonsynonymous variant, and a good way of running several of them together would be via Annovar 
The following paper is a good guide to whether a variant should be described as benign or pathogenic, based on available evidence:
  • asked a question related to Mutation Analysis
Question
3 answers
Shedding of BK virus in urine is pretty common in kidney transplant recipients and even some times in healthy people however viremia is much less common. We preformed PCR to detect both viremia and viruria,  and about 10% of patients with viruria showed viremia simultaneously.
Presence of virmeia increases the chance of nephropathy. I was wondering if there is a connection between specific virus genotype or mutants and viremia or clinical outcome.
Relevant answer
Answer
Dear Dr. Bialasiewicz
Thanks for your answer it is very insight full. I would appreciate it if you could guide me more.
I am planning to sequence our BKv isolates from virmic patients. Do you have any suggestion which part of genome is better for sequencing in order to define subtypes of virus?
Best regtards
Davod
  • asked a question related to Mutation Analysis
Question
4 answers
analysing EDIL3 gene in the tumour cell line MDA-MB231, were a non-somatic mutation was found. 
Relevant answer
Answer
The pS318S silent variant is likely to have a neutral effect and cause no phenotype modification in you cell line.
A 30:70 ratio between allele A and G indicates heterogeneity in your cell line, but does not provides clear evidence supporting a mutation event generating the A allele.
this variant is annotated as rs2269287. MAF is 15%, so it is not a mutation but a polymorphism.
i guess it is likely that the studied cell line has an heterozygous genotype (G/A), as heterozygotes are around 1/3 of general population.
the observed 30:70 ratio could be just casual, if read depth is low. Otherwise could be an effect of partial LOH due to deletion. In this case it would be important to check if variant lies in an area with apparent homozygosity.
  • asked a question related to Mutation Analysis
Question
5 answers
I tried to do site directed mutagenesis several times I used takara enzyme to do the reaction
I did the digestion with DpnI and I also use negative control (using the template with and digested it with DpnI )and did the transformation. With the negative control I got no colony which means the DpnI worked pretty well and I got several colonies with the reaction mixture.
so I purified the plasmid after I grew the bacteria in LB medium.
I sequence the plasmid but I did not get the desired point mutation.
the resulting sequence was exactly as the template ???
what should I do to optimize or fix this problem?
Relevant answer
Answer
the primer length was 36 nucleotides and the changed nucleotide was in the middle?!
  • asked a question related to Mutation Analysis
Question
4 answers
For lysine mutation
will the mutation affect the quartary structure of proteins?
Relevant answer
Answer
I don't think there are any generally applicable rules for predicting the effect of site-directed mutagenesis. Alanine-scanning mutagenesis is often done, but other changes may be made for specific reasons. Some changes are more conservative than others. Changing between a small side chain and a large one, or altering the charge of a side chain, is most likely to have a substantial effect on the secondary, tertiary, and/or quaternary structure, especially if that side chain is involved in interactions or folding. In some cases, even seemingly minor changes (e.g. Ser to Ala) can be devastating to the folding of the protein. If the change is made at the interface between subunits, a change in quaternary structure may well result.
  • asked a question related to Mutation Analysis
Question
4 answers
What ways are there to find a mutation on a specific gene "in vivo"?
Que formas existen para detectar la presencia de una mutacion en un determinado gen sin necesidad de extraer el tejido de un paciente?
Relevant answer
Answer
Thanks, that would work, sadly, it still requires taking tissue from the patient, thing is that this mutation could probably be found in a few cells that could be scattered along the organ, so ideally i would need to mark those cells without touching them.
  • asked a question related to Mutation Analysis
Question
7 answers
I would like to understand the reason behind the silent mutation and nonsense mutation in house keeping genes. Since I am working with multidrug resistant bacteria, i would like to know if there is any positive correlation between this silent mutation and resistance(or survival of the organism).
Relevant answer
Answer
Hi Nithin,
1. The classic view of 'Silent mutation' is that silent mutations do not cause changes in the amino acid sequence, hence the protein is supposed still to be functional, and pose no consequence for the organisms.
2. However, recently this view has changed. Researchers have found that silent mutations do cause changes and affect the organism [see attachment 1]. Some examples are:
[1] Silent mutation have greatly changed the mRNA structures and reduce the translation speed. For one study, the assay showed that an unexpected one-third of silent mutations caused protein translation to slow down, in some cases decreasing the speed by as much as five-fold [see attachments 2].
[2] Artificially induced silent mutations (by introducing 5 rare codons) has significantly changed a protein's property. See paper: "Silent mutations result in HlyA hypersecretion by reducing intracellular HlyA protein aggregates " [ http://www.ncbi.nlm.nih.gov/pubmed/18553505 ]
3. If a protein's property can be changed by silent mutations [as stated in the above [2] study], silent mutations might also have the ability to induce 'drug resistance' of a bacteria by altering a specific gene.  This can due to the changed protein cannot be recognized by antibiotics anymore. However, this has to be checked out experimentally. For your experiments, you can consider to design and introduce some artificial silent mutations on a particular gene (in your case, you said " a house-keeping gene") and see any drug-resistance occur for the bacteria. Some companies provide 'codon usage' service, such as GeneScrip. You can use their services to change your gene with a price (not cheap).
  • asked a question related to Mutation Analysis
Question
3 answers
There are many tools for in silico mutation analyses: mutation taster, polyphen, sift, muytationassessor...The results and values could change according to each tool; so it is important to evaluate the results in all the tools. Is there any tool that we could evalute the results of all the in silico tools inside it and make a clear desicion? Thanks.
Relevant answer
Answer
I would recommend trying dbNSFP. dbNSFP compiles prediction scores from 14 prediction algorithms and 6 conservation scores. Two of the prediction scores/tools - MetaSVM and MetaLR are based on the scores/predictions from about 18 prediction tools. dbNSFP could be used as plugin with Ensembl's variant effect predictor (vep).
  • asked a question related to Mutation Analysis
Question
1 answer
I am looking for a formula to compare the mutation load of different polygenic diseases in the genomic data of a distinct population. An example data is attached herewith. 
Relevant answer
Answer
Hello,
Perhaps this link to a scientific paper could be helpful
You can also read the article of KIMURA, M., 1961 "Some calculations on the mutational load".published in the Jap. Jour. Genet. 
Best wishes
  • asked a question related to Mutation Analysis
Question
3 answers
I'm working on this cell line and know only that MDA-MB231 is TNBC, highly aggressive & metastatic while MCF10A is immortalised non cancerous cell line.But i want to know what changes lead to development of these 2 different cell line?
Thanks in advence.
Relevant answer
Answer
hiiii Zhang,
Thanx for reply.Can you please give me more information on MDAMB231?
And any information about mutation in MCF10A.?
  • asked a question related to Mutation Analysis
Question
2 answers
Relevant answer
Answer
There is a review article (see references within)  for several protocols.
"Improving industrial yeast strains: exploiting natural and
artificial diversity"  (Steensels et al, 2014)
  • asked a question related to Mutation Analysis
Question
1 answer
I am going to detect BRAF v600e mutation in colorectal cancer sample and currently looking for appropriate methods to compare and to use. I am thinking of doing MEMO-PCR but still lack of information about the disadvantages of this method, comparing to prior methods.
Relevant answer
Answer
Dear Juli,
The following publication describes the mentioned method (MEMO) along with its limitations and advantages. The opinions depicted in this article are for some experts in the field:
Korean Group Develops Inexpensive Sequence-Enrichment Method for Mutation Detection
Nov 03, 2011
Premium
By Ben Butkus
Scientists from Korea's Samsung Medical Center have developed a sequence-enrichment technique for identifying trace mutant DNA sequences in a high background of normal DNA, according to research published last month.
The method, called mutant enrichment with 3'-modified oligonucleotides, or MEMO, can be used in tandem with quantitative real-time PCR, high-resolution melt curve analysis, or downstream Sanger sequencing to detect common cancer mutations with a high degree of sensitivity and specificity, and is cheaper and easier to use than existing methods, according to the researchers.
Despite the technique's potential cost savings, however, it may not provide the same degree of enrichment for downstream PCR analysis as current methods, and may not be able to enrich unknown mutations in longer sequence stretches, according to one expert.
The researchers from Samsung Medical Center, an independent research institute and teaching hospital of the Sungkyunkwan University School of Medicine, described the MEMO method in a paper published in October in theJournal of Molecular Diagnostics.
The technique, they wrote, is similar to PCR clamping techniques that use peptide nucleic acids or locked nucleic acids — the rights of which are owned by Life Technologies and Exiqon, respectively — to increase probe specificity and binding strength.
However, in MEMO the PNA or LNA is replaced by 3'-modified oligonucleotides that feature an extension-inhibiting compound on their 3' ends and are added to a PCR reaction mixture along with two generic primers.
The blocking primer encompasses the target mutation site and complements the wild-type sequences. One of the two generic primers overlaps with the blocking primer by several bases, neighboring the target mutation site and thus competing with the blocking primer, the researchers wrote.
In turn, the DNA binding of the blocking primer "dominates for wild-type sequences, whereas its affinity for mutant sequences is markedly reduced due to mismatches," the researchers wrote. "The loss of competition of the blocking primer enables selective amplification of mutant sequences by the generic primer pair."
As described in the JMD paper, the Korean researchers evaluated the ability of the MEMO method to detect common cancer mutations in the EGFR, KRAS, BRAF, TP53, JAK2, and NPM1 genes, and observed sensitivities ranging from 10-2 to 10-6 when combining the technique with downstream Sanger sequencing.
According to the researchers, this sensitivity depends on the properties of the primers and the experimental conditions, as well as the nature of the mutation and its surrounding sequences.
In addition, although MEMO can potentially be coupled with subsequent quantitative real-time PCR and melting curve analysis, the researchers found that the technique's sensitivity suffered in these instances.
"Although MEMO-PCR and Sanger sequencing showed sensitivities up to 10-6, MEMO-PCR and melting curve analysis showed ambiguous patterns in samples with very low mutant concentrations (from 10-6 to 10-4)," the researchers wrote. "This might be attributed to the fact that the resolution of melting curve analysis is affected by many factors including template or final DNA concentrations."
Nevertheless, the authors claimed that at the very least, MEMO combined with Sanger sequencing resulted in sensitivities similar to those of PNA- or LNA-mediated methods, and the MEMO probes "are much less expensive and are easy to design."
It is unclear how much less expensive MEMO probe design would be compared to PNAs or LNAs. The Korean researchers did not provide cost details in their paper, and the corresponding author could not be reached for comment.
Mike Makrigiorgos, an associate professor and director of medical physics and biophysics at Dana-Farber Cancer Institute and inventor of a competing enrichment method — co-amplification at lower denaturation temperature, or COLD-PCR — told PCR Insider this week that although the MEMO technique was "elegant," it seemed to be a minor modification of concepts that have existed for a while.
"PNA [and] LNA probes that operate on the same principle as MEMO have been known for a while," Makrigiorgos said. And while he agreed that PNA/LNA probes are more expensive than MEMO probes, "one would expect that they provide a better enrichment of mutant DNA during PCR. Finally, high-resolution melting techniques already use unmodified oligonucleotides … similar to MEMO … to identify base changes and SNPs following PCR."
Makrigiorgos also noted that COLD-PCR and an improved version recently developed in his lab called Ice-COLD PCR have an advantage over MEMO and techniques such as PNA- and LNA-mediated clamping because "they uniquely enable enrichment of unknown mutations at any position of longer sequences," for example, of 150 to 200 basepairs, "and hence match well with downstream sequencing technologies. Techniques like MEMO and LNA/PNA essentially address mutations at known positions of sequences up to 20 bases long."
Indeed, the Korean researchers noted in their paper that current limitations of MEMO include the fact that "only mutations in a known target region (within the coverage of blocking primers) can be enriched, and sensitivities may vary according to different base substitutions in the same target regions."
Even so, the researchers believe that MEMO has the potential to provide a cheap and easy alternative in situations where "minority alleles of clinical significance are present and sensitive detection is required."
Besides cancer mutation detection, the authors suggest that the technique can be useful for identifying variant strains in infectious diseases, detecting minor mutant alleles in patients with low-level somatic mosaicism or mitochondrial heteroplasmy, and characterizing fetal mutations from maternal plasma samples.
To view the original article, please use the following link:
I am also attaching the original paper in which full description of the method is illustrated.
Hoping this will be helpful,
Rafik
  • asked a question related to Mutation Analysis
Question
6 answers
If the DNA's replication goes wrong, mutation occur. Why does an organism have up to 3 mutations only? 
Relevant answer
Answer
Dear Ismali,
I think you read something in other context and interpreted as 3 mutations limit. I am
sorry there is something wrong.
  • asked a question related to Mutation Analysis
Question
6 answers
Iam doing research on the molecular phylogeography of the giant african snail in India. How can I calculate the mutation rate/time (time from which the change has occurred in the sequence)? Is there some specific software which could be used for that?
Relevant answer
Answer
As an alternative you can try to use known mutation rates of closely related species (e.g. other terrestrial snails) to calculate the time since two alleles diverged. This may lead to wrong estimates if the number of mutations is very low. The calculation can be done in BEAST or as an estimate by hand (knowing the number of mutations and the rate of mutations/unit of time).