Posts by Year

2023

Reverse Transcription - C.gigas PolyIC Diploid MgCl2

  • ~1 min read

After quantifying diploid MgCl2 (Notebook) earlier today and proceeded to make cDNA. Reverse transcription was performed using oligo dT primers using M-MLV RT (Promega), per the manufacturer’s recommendations. Used 400ng of RNA in each reaction. I used 400ng (instead of the usual 100ng) to simplify pipetting for high concentration samples, without the need/time to dilute samples. All reactions were done on ice in 0.5uL PCR tubes.

Read More

RNA Quantification - C.gigas PolyIC Diploid MgCl2

  • ~1 min read

Steven asked me to generate cDNA (GitHub Issue) from Crassostrea gigas (Pacific oyster) RNA, as part of Matt George’s polyIC project. I had previously quantified RNA from five diploid and five triploid samples (Notebook), but the qPCR results (Notebook) didn’t reveal much. Plus, the diploids and triploids weren’t the same treatment types (i.e. the diploids were poly:IC-injected, whereas the triploids were controls - so they weren’t really comparable). So, Steven asked that I find comparable set of samples so that we’d have either diploid controls or triploids which were poly:IC-injected. Looking in the freezer box for samples (Google sheet), I found four diploid MgCl2 control RNA samples. Before starting reverse transcription, I felt it would be best to quantify the RNA using the Qubit 3.0 using the Broad Range Assay. Steven and I discussed which samples to use earlier this week.

Read More

Data Wrangling - C.virginica Genes Only FastA from Genes BED File Using gffread on Raven

  • ~1 min read

I’ve been reviewing some of the CEABIGR (GitHub repo) data I’ve generated; specifically transcript count data/calcs. As part of that, I feel like we need/should annotate the transcripts to be able to make some more informed conclusions. Steven had previously performed annotations (Notebook), as well as Yaamini (GitHub Issue). However, there are shortcomings to both of the approaches each one utilized. Steven’s annotation relied only on coding sequences (CDS), while Yaamini’s utilized only mRNAs.

Read More

Reverse Transcription - C.gigas PolyIC RNA

  • ~1 min read

Quantified RNA earlier today and proceeded to make cDNA. Reverse transcription was performed using oligo dT primers using M-MLV RT (Promega), per the manufacturer’s recommendations. Used 400ng of RNA in each reaction. I used 400ng (instead of the usual 100ng) to simplify pipetting for high concentration samples, without the need/time to dilute samples. All reactions were done on ice in 0.5uL PCR tubes.

Read More

File Conversion - M.magister MEGANized DAA to RMA6

  • 4 min read

After the initial DIAMOND BLASTx and subsequent MEGANization(notebook) ran for 41 days, I attempted to open the extremely large files in the MEGAN6 GUI to get an overview of taxonomic breakdown. Due to the large file sizes (the smallest is 68GB!), the GUI consistently crashed. Also, each attempt took an hour or two before it would crash. Looking into this a bit more, I realized that I needed to convert the MEGANized DAA files to RMA6 format before attempting to import into the MEGAN6 GUI! Gah! The RMA6 files are significantly smaller (like “only” 2GB) and there should be ample memory to import them.

Read More

Trimming and QC - E5 Coral sRNA-seq Data fro A.pulchra P.evermanni and P.meandrina Using FastQC flexbar and MultiQC on Mox

  • 6 min read

After downloading (notebook) and then reorganizing the E5 coral RNA-seq data from Azenta project 30-789513166 (notebook), and after testing some trimming options for sRNA-seq data (notebook), I opted to use the trimming software flexbar. I ran FastQC for initial quality checks, followed by trimming with flexbar, and then final QC with FastQC/MultiQC. This was performed on all three species in the data sets: A.pulchra, P.evermanni, and P.meandrina. All aspects were run on Mox. Final trimming length was set to 35bp.

Read More

ORF Identification - L.staminea De Novo Transcriptome Assembly v1.0 Using Transdecoder on Mox

  • 2 min read

After performing a de novo transcriptome assembly with L.staminea RNA-seq data, the Trinity assembly stats were quite a bit more “exaggerated” than normally expected. In an attempt to get a better sense of which contigs might be more useful candidates for downstream analysis, I decided to run the assembly through Transdecoder to identify open reading frames (ORFs). This was run on Mox.

Read More

Trimming and QC - E5 Coral sRNA-seq Trimming Parameter Tests and Comparisons

  • 2 min read

In preparation for FastQC and trimming of the E5 coral sRNA-seq data, I noticed that my “default” trimming settings didn’t produce the results I expected. Specifically, since these are sRNAs and the NEBNext® Multiplex Small RNA Library Prep Set for Illumina (PDF) protocol indicates that the sRNAs should be ~21 - 30bp, it seemed odd that I was still ending up with read lengths of 150bp. So, I tried a couple of quick trimming comparisons on just a single pair of sRNA FastQs to use as examples to get feeback on how trimming should proceed.

Read More

Data Wrangling - P.meandrina Genome GFF to GTF Using gffread

  • ~1 min read

As part of getting P.meandrina genome info added to our Lab Handbook Genomic Resources page, I will index the P.meandrina genome file (Pocillopora_meandrina_HIv1.assembly.fasta) using HISAT2, but need a GTF file to also identify exon/intro splice sites. Since a GTF file is not available, but a GFF file is, I needed to convert the GFF to GTF. Used gffread to do this on my computer. Process is documented in Jupyter Notebook linked below.

Read More

FastQ QC and Trimming - E5 Coral RNA-seq Data for A.pulchra P.evermanni and P.meandrina Using FastQC fastp and MultiQC on Mox

  • 5 min read

After downloading and then reorganizing the E5 coral RNA-seq data from Azenta project 30-789513166, I ran FastQC for initial quality checks, followed by trimming with fastp, and then final QC with FastQC/MultiQC. This was performed on all three species in the data sets: A.pulchra, P.evermanni, and P.meandrina. All aspects were run on Mox.

Read More

Data Management - E5 Coral RNA-seq and sRNA-seq Reorganizing and Renaming

  • ~1 min read

Downloaded the E5 coral sRNA-seq data from Azenta project 30-852430235 on 20230515 and the E5 coral RNA-seq data from Azenta project 30-789513166 on 20230516. The data required some reorganization, as the project included data from three different species (Acropora pulchra, Pocillopora meandrina, and Porites evermanni). Additionally, since the project was sequencing the same exact samples with both RNA-seq and sRNA-seq, the resulting FastQ files ended up being the same. This fact seemed like it could lead to potential downstream mistakes and/or difficulty tracking whether or not someone was actually using an RNA-seq or an sRNA-seq FastQ.

Read More

lncRNA Identification - P.generosa lncRNAs using CPC2 and bedtools

  • ~1 min read

After trimming P.generosa RNA-seq reads on 20230426 and then aligning and annotating them to the Panopea-generosa-v1.0 genome on 20230426, I proceeded with the final step of lncRNA identification. To do this, I used Zach’s notebook entry on lncRNA identification for guidance. I utilized the annotated GTF generated by gffcompare during the alignment/annotation step on 20230426. I used ‘bedtools getfasta](https://bedtools.readthedocs.io/en/latest/content/tools/getfasta.html) and [CPC2` with an aribtrary 200bp minimum length to identify lncRNAs. All of this was done in a Jupyter Notebook (links below).

Read More

Containers - Apptainer Explorations

  • 6 min read

At some point, our HPC nodes on Mox will be retired. When that happens, we’ll likely purchase new nodes on the newest UW cluster, Klone. Additionally, the coenv nodes are no longer available on Mox. One was decommissioned and one was “migrated” to Klone. The primary issue at hand is that the base operating system for Klone appears to be very, very basic. I’d previously attempted to build/install some bioinformatics software on Klone, but could not due to a variety of missing libraries; these libraries are available by default on Mox… Part of this isn’t surprising, as UW IT has been making a concerted effort to get users to switch to containerization - specifically using Apptainer (formerly Singularity) containers.

Read More

Transcript Alignments - P.generosa RNA-seq Alignments for lncRNA Identification Using Hisat2 StingTie and gffcompare on Mox

  • 10 min read

This is a continuation of the process for identification of lncRNAs,. I aligned FastQs which were previously trimmed earlier today to our Panopea-generosa-v1.0 genome FastA using HISAT2. I used the HISAT2 genome index created on 20190723, which was created with options to identify exons and splice sites. The GFF used was from 20220323. StringTie was used to identify alternative transcripts, assign expression values, and create expression tables for use with ballgown. The job was run on Mox.

Read More

FastQ Trimming and QC - P.generosa RNA-seq Data from 20220323 on Mox

  • 4 min read

Addressing the update to this GitHub Issue regarding identifying Panopea generosa (Pacific geoduck) long non-coding RNAs (lncRNAs), I used the RNA-seq data from the Nextflow NF-Core RNAseq pipeline run on 20220323. Although that data was supposed to have been trimmed in the Nextflow NF-Core RNA-seq pipeline, the FastQC reports still show adapter contamination and some funky stuff happening at the 5’ end of the reads. So, I’ve opted to trim the “trimmed” files with fastp, using a hard 20bp trim at the 5’ end of all reads. FastQC and MultiQC were run before/after trimming. Job was run on Mox.

Read More

Data Wrangling - Append Gene Ontology Aspect to P.generosa Primary Annotation File

  • 1 min read

Steven tasked me with updating our P.generosa genome annotation file (GitHub Issue) a while back and I finally managed to get it all figured out. Although I wanted to perform most of this using the GSEAbase package (PDF), as this package is geared towards storage/retrieval of gene set data, I eventually decided to abondon this approach due to the time it was taking and my lack of familiarity/understanding of how to manipulate objects in R. Despite that, GSEAbase was still utilized for its very simple use for identifying GOlims (IDs and Terms).

Read More

Sequencing Read Taxonomic Classification - P.verrucosa E5 RNA-seq Using DIAMOND BLASTx and MEGAN daa-meganizer on Mox

  • 5 min read

After some discussion with Steven at Science Hour last week regarding the handling of endosymbiont sequences in the E5 P.verrucosa RNA-seq data, Steven thought it would be interesting to run the RNA-seq reads through MEGAN6 just to see what the taxonomic breakdown looks like. We may or may not (probably not) separating reads based on taxonomy. In the meantime, we’ll still proceed with HISAT2 alignments to the respective genomes as a means to separate the endosymbiont reads from the P.verrucosa reads.

Read More

Data Wrangling - C.goreaui Genome GFF to GTF Using gffread

  • ~1 min read

As part of getting these three coral species genome files (GitHub Issue) added to our Lab Handbook Genomic Resources page, I also need to get the coral endosymbiont sequence. After talking with Danielle Becker in Hollie Putnam’s Lab at Univ. of Rhode Island, she pointed me to the Cladocopium goreaui genome from Chen et. al, 2022 available here. Access to the genome requires agreeing to some licensing provisions (primarily the requirment to cite the publication whenever the genome is used), so I will not be providing any public links to the file. In order to index the Cladocopium goreaui genome file (Cladocopium_goreaui_genome_fa) using HISAT2 for downstream isoform analysis using StringTie and ballgown, I need a corresponding GTF to also identify exon/intro splice sites. Since a GTF file is not available, but a GFF file is, I needed to convert the GFF to GTF. Used gffread to do this on my computer. Process is documented in Jupyter Notebook linked below.

Read More

Transcript Identification and Alignments - P.verrucosa RNA-seq with Pver_genome_assembly_v1.0 Using HiSat2 and Stringtie on Mox

  • 19 min read

After getting the RNA-seq data trimmed, it was time to perform alignments and determine expression levels of transcripts/isoforms using with HISAT2 and StringTie, respectively. StringTie was set to output tables formatted for import into ballgown. After those two analyses were complete, I ran gffcompare, using the merged StringTie GTF and the input GFF3. I caught this in one of Danielle Becker’s scripts and thought it might be interesting. The analsyes were run on Mox.

Read More

FastQ Trimming and QC - P.verrucosa RNA-seq Data from Danielle Becker in Hollie Putnam Lab Using fastp FastQC and MultiQC on Mox

  • 5 min read

After receiving the P.verrucosa RNA-seq data from Danielle Becker (Hollie Putnam’s Lab, Univ. of Rhode Island), I noticed that the trimmed reads didn’t appear to actually be trimmed. There was still adapter contamination (solely in R2 reads - suggesting the detect_adapter_for_pe option had been omitted from the fastp command?), but the reads had an average read length of 150bp - except when looking at the adapter content report!!??.

Read More

Data Wrangling - P.verrucosa Genome GFF to GTF Using gffread

  • ~1 min read

As part of getting these three coral species genome files (GitHub Issue) added to our Lab Handbook Genomic Resources page, I will index the P.verrucosa genome file (Pver_genome_assembly_v1.0.fasta) using HISAT2, but need a GTF file to also identify exon/intro splice sites. Since a GTF file is not available, but a GFF file is, I needed to convert the GFF to GTF. Used gffread to do this on my computer. Process is documented in Jupyter Notebook linked below.

Read More

Data Wrangling - M.capitata Genome GFF to GTF Using gffread

  • ~1 min read

As part of getting these three coral species genome files (GitHub Issue) added to our Lab Handbook Genomic Resources page, I will index the M.capitata genome file (Montipora_capitata_HIv3.assembly.fasta) using HISAT2, but need a GTF file to also identify exon/intro splice sites. Since a GTF file is not available, but a GFF file is, I needed to convert the GFF to GTF. Used gffread to do this on my computer. Process is documented in Jupyter Notebook linked below.

Read More

Data Wrangling - P.acuta Genome GFF to GTF Conversion Using gffread

  • ~1 min read

As part of getting these three coral species genome files (GitHub Issue) added to our Lab Handbook Genomic Resources page, I will index the P.acuta genome file using HISAT2, but need a GTF file to also identify exon/intro splice sites. Since a GTF file is not available, but a GFF file is, I needed to convert the GFF to GTF. Used gffread to do this on my computer. Process is documented in Jupyter Notebook linked below.

Read More

Back to Top ↑

2022

Data Wrangling - C.virginica NCBI GCF_002022765.2 GFF to Gene and Pseudogene Combined BED File

  • ~1 min read

Working on the CEABIGR project, I was preparing to make a gene expression file to use in CIRCOS (GitHub Issue) when I realized that the Ballgown gene expression file (CSV; GitHub) had more genes than the C.virginica genes BED file we were using. After some sleuthing, I discovered that the discrepancy was caused by the lack of pseudogenes in the genes BED file I was using. Although it might not really have any impact on things, I thought it would still be prudent to have a BED file that completely matched all of the genes in the Ballgown gene expression file. Plus, having the pseudogenes might be of longterm usefulness if we we ever decide to evalute the role of long non-coding RNAs (lncRNAs) in this project.

Read More

Data Wrangling - Identify C.virginica Genes with Different Predominant Isoforms for CEABIGR

  • ~1 min read

During today’s discussion, Yaamini recommended we generate a list of genes with different predominant isoforms between females and males, while also adding a column with a binary indicator (e.g. 0 or 1) to mark those genes which were not different (0) or were different (1) between sexes. Steven had already generated files identifying predominant isoforms in each sex:

Read More

RNAseq Alignments - P.generosa Alignments and Alternative Transcript Identification Using Hisat2 and StringTie on Mox

  • 15 min read

As part of identifying long non-coding RNA (lncRNA) in Pacific geoduck(GitHub Issue), one of the first things that I wanted to do was to gather all of our geoduck RNAseq data and align it to our geoduck genome. In addition to the alignments, some of the examples I’ve been following have also utilized expression levels as one aspect of the lncRNA selection criteria, so I figured I’d get this info as well.

Read More

qPCR - Repeat of Mussel Gill Heat Stress cDNA with Ferritin Primers

  • ~1 min read

My previous qPCR on these cDNA using ferritin primers (SRIDs: 1808, 1809) resulted in no amplification. This was a bit surprising and makes me suspect that I screwed up somewhere (not adding primer(s)??), so I decided to repeat the qPCR. I made fresh working primer stocks and used 1uL of cDNA for each reaction. All reactions were run in duplicate on our CFX Connect thermalcycler (BioRad) with SsoFast EVAgreen Master Mix (BioRad). See my previous post linked above for qPCR master mix calcs.

Read More

Data Wrangling - Create Primary P.generosa Genome Annotation File

  • 1 min read

Steven asked me to create a canonical genome annotation file (GitHub Issue). I needed/wanted to create a file containing gene IDs, SwissProt (SP) IDs, gene names, gene descriptions, and gene ontology (GO) accessions. To do so, I utilized the NCBI BLAST and DIAMOND BLAST annotations generated by our GenSas P.generosa genome annotation. Per Steven’s suggestion, I used the best match (i.e. lowest e-value) for any given gene between the two files.

Read More

Server Maintenance - Fix Server Certificate Authentication Issues

  • 2 min read

We had been encounterings issues when linking to images in GitHub (e.g. notebooks, Issues/Discussions) hosted on our servers (primarily Gannet). Images always showed up as broken links and, with some work, we could see an error message related to server authentication. More recently, I also noticed that Jupyter Notebooks hosted on our servers could not be viewed in NB Viewer. Attempting to view a Jupyter Notebook hosted on one of our servers results in a 404 error, with a note regarding server certificate problems. Finally, the most annoying issue was encountered when running the shell programs wget to retrieve files from our servers. This program always threw an error regarding our server certificates. The only way to run wget without this error was to add the option --no-check-certificate (which, thankfully, was a suggestion by wget error message).

Read More

Data Wrangling - P.generosa Genomic Feature FastA Creation

  • 1 min read

Steven wanted me to generate FastA files (GitHub Issue) for Panopea generosa (Pacific geoduck) coding sequences (CDS), genes, and mRNAs. One of the primary needs, though, was to have an ID that could be used for downstream table joining/mapping. I ended up using a combination of GFFutils and bedtools getfasta. I took advantage of being able to create a custom name column in BED files to generate the desired FastA description line having IDs that could identify, and map, CDS, genes, and mRNAs across FastAs and GFFs.

Read More

Differential Gene Expression - P.generosa DGE Between Tissues Using Nextlow NF-Core RNAseq Pipeline on Mox

  • 7 min read

Steven asked that I obtain relative expression values for various geoduck tissues (GitHub Issue). So, I decided to use this as an opportunity to try to use a Nextflow pipeline. There’s an RNAseq pipeline, NF-Core RNAseq which I decided to use. The pipeline appears to be ridiculously thorough (e.g. trims, removes gDNA/rRNA contamination, allows for multiple aligners to be used, quantifies/visualizes feature assignments by reads, performs differential gene expression analysis and visualization), all in one package. Sounds great, but I did have some initial problems getting things up and running. Overall, getting things set up to actually run took longer than the actual pipeline run! Oh well, it’s a learning process, so that’s not totally unexpected.

Read More

Data Analysis - C.virginica RNAseq Zymo ZR4059 Analyzed by ZymoResearch

  • 2 min read

After realizing that the Crassostrea virginica (Eastern oyster) RNAseq data had relatively low alignment rates (see this notebook entry from 20220224 for a bit more background), I contacted ZymoResearch to see if they had any insight on what might be happening. I suspected rRNA contamination. ZymoResearch was kind enough to run the RNAseq data through their pipeline and provided us. This notebook entry provides a brief overview and thoughts on the report.

Read More

Transcript Identification and Alignments - C.virginica RNAseq with NCBI Genome GCF_002022765.2 Using Hisat2 and Stringtie on Mox

  • 14 min read

After an additional round of trimming yesterday, I needed to identify alternative transcripts in the Crassostrea virginica (Eastern oyster) gonad RNAseq data we have. I previously used HISAT2 to index the NCBI Crassostrea virginica (Eastern oyster) genome and identify exon/splice sites on 20210720. Then, I used this genome index to run StringTie on Mox in order to map sequencing reads to the genome/alternative isoforms.

Read More

Trimming - Additional 20bp from C.virginica Gonad RNAseq with fastp on Mox

  • 6 min read

When I previously aligned trimmed RNAseq reads to the NCBI C.virginica genome (GCF_002022765.2) on 20210726, I specifically noted that alignment rates were consistently lower for males than females. However, I let that discrepancy distract me from a the larger issue: low alignment rates. Period! This should have thrown some red flags and it eventually did after Steven asked about overall alignment rate for an alignment of this data that I performed on 20220131 in preparation for genome-guided transcriptome assembly. The overall alignment rate (in which I actually used the trimmed reads from 20210714) was ~67.6%. Realizing this was a on the low side of what one would expect, it prompted me to look into things more and I came across a few things which led me to make the decision to redo the trimming:

Read More

Data Wrangling - C.virginica lncRNA Extractions from NCBI GCF_002022765.2 Using GffRead

  • ~1 min read

Continuing to work on our Crassostrea virginica (Eastern oyster) project examining the effects of OA on female and male gonads (GitHub repo), Steven tasked me with parsing out long, non-coding RNAs (GitHub Issue). To do so, I relied on the NCBI genome and associated files/annotations. I used GffRead, GFFutils, and samtools. The process was documented in the followng Jupyter Notebook:

Read More

Transcriptome Assembly - Genome-guided C.virginica Adult Gonad OA RNAseq Using Trinity on Mox

  • 4 min read

As part of this project, Steven’s asked that I identify long, non-coding RNAs (lncRNAs) (GitHub Issue) in the Crassostrea virginica (Eastern oyster) adult OA gonad RNAseq data we have. The initial step for this is to assemble transcriptome. I generated the necessary BAM alignment on 20220131. Next was to actually get the transcriptome assembled. I followed the Trinity genome-guided procedure.

Read More

RNAseq Alignment - C.virginica Adult OA Gonad Data to GCF_002022765.2 Genome Using HISAT2 on Mox

  • 5 min read

As part of this project, Steven’s asked that I identify long, non-coding RNAs (lncRNAs) (GitHub Issue) in the Crassostrea virginica (Eastern oyster) adult OA gonad RNAseq data we have. The initial step for this is to assemble transcriptome. Since there is a published genome (NCBI RefSeq GCF_002022765.2C_virginica-3.0)](https://ftp.ncbi.nlm.nih.gov/genomes/all/GCF/002/022/765/GCF_002022765.2_C_virginica-3.0/) for [_Crassostrea virginica (Eastern oyster), I will perform a genome-guided assembly using Trinity. That process requires a sorted BAM file as input. In order to generate that file, I used HISAT2. I’ve already generated the necessary HISAT2 genome index files (as of 20210720), which also identified/incorporated splice sites and exons, which the HISAT2 alignment process requires to run.

Read More

Data Wrangling - C.virginica Gonad RNAseq Transcript Counts Per Gene Per Sample Using Ballgown

  • ~1 min read

As we continue to work on the analysis of impacts of OA on Crassostrea virginica (Eastern oyster) gonads via DNA methylation and RNAseq (GitHub repo), we decided to compare the number of transcripts expressed per gene per sample (GitHub Issue). As it turns out, it was quite the challenge. Ultimately, I wasn’t able to solve it myself, and turned to StackOverflow for a solution. I should’ve just done this at the beginning, as I got a response (and solution) less than five minutes after posting! Regardless, the data wrangling progress (struggle?) was documented in the following GitHub Discussion:

Read More

Project Summary - Matt George PSMFC Mytilus Byssus Project

  • ~1 min read

This will be a “dynamic” notebook entry, whereby I will update this post continually as I process new samples, analyze new data, etc for this project. The hope is to make it easier to find all the work I’ve done for this without having to search my notebook to find individual notebook entries.

Read More

RNA Isolation - M.trossulus Gill and Phenol Gland

  • 2 min read

As part of a mussel project that Matt George has with the Pacific States Marine Fisheries Commission (PSMFC), I’m helping by continuing isolating RNA from a relatively large number of samples. The samples are listed/described in this GitHub Issue. Today, I isolated RNA from the following samples (the “F” indicates “foot”, “PG” indicates “phenol gland”, and “G” indicates “gill” tissues):

Read More

RNA Isolation - M.trossulus Gill and Phenol Gland

  • 1 min read

As part of a mussel project that Matt George has with the Pacific States Marine Fisheries Commission (PSMFC), I’m helping by continuing isolating RNA from a relatively large number of samples. The samples are listed/described in this GitHub Issue. Today, I isolated RNA from the following samples (the “F” indicates “foot”, “PG” indicates “phenol gland”, and “G” indicates “gill” tissues):

Read More

RNA Isolation - M.trossulus Gill and Phenol Gland

  • 2 min read

As part of a mussel project that Matt George has with the Pacific States Marine Fisheries Commission (PSMFC), I’m helping by continuing isolating RNA from a relatively large number of samples. The samples are listed/described in this GitHub Issue. Today, I isolated RNA from the following samples (the “F” indicates “foot”, “PG” indicates “phenol gland”, and “G” indicates “gill” tissues):

Read More

Back to Top ↑

2021

RNA Isolation - M.trossulus Phenol Gland and Gill

  • 2 min read

As part of a mussel project that Matt George has with the Pacific States Marine Fisheries Commission (PSMFC), I’m helping by continuing isolating RNA from a relatively large number of samples. The samples are listed/described in this GitHub Issue. Today, I isolated RNA from the following samples (the “F” indicates “foot”, “PG” indicates “phenol gland”, and “G” indicates “gill” tissues):

Read More

Project Summary - O.nerka Berdahl Samples

  • ~1 min read

This will be a “dynamic” notebook entry, whereby I will update this post continually as I process new samples, analyze new data, etc for this project. The hope is to make it easier to find all the work I’ve done for this without having to search my notebook to find individual notebook entries.

Read More

RNA Isolation - O.nerka Berdahl Tissues

  • 3 min read

Finally got around to tackling this GitHub issue regarding isolating RNA from some Oncorhynchus nerka (sockeye salmon) tissues we have from Andrew Berdahl’s lab (a UW SAFS professor) to use for RNAseq and/or qPCR. We have blood, brain, gonad, and liver samples from individual salmon from two different groups: territorial and social individuals. We’ve decided to isolate RNA from brain, gonads, and liver from two individuals within each group. All samples are preserved in RNAlater and stored @ -80oC.

Read More

Data Wrangling - C.virginica NCBI GCF_002022765.2 GFF to Gene BED File

  • 1 min read

When working to identify differentially expressed transcripts (DETs) and genes (DEGs) for our Crassostrea virginica (Eastern oyster) RNAseq/DNA methylation comparison of changes across sex and ocean acidification conditions (https://github.com/epigeneticstoocean/2018_L18-adult-methylation), I realized that the DEG tables I was generating had excessive gene counts due to the fact that the analysis (and, in turn, the genome coordinates), were tied to transcripts. Thus, genes were counted multiple times due to the existence of multiple transcripts for a given gene, and the analysis didn’t list gene coordinate data - only transcript coordinates.

Read More

Differential Transcript Expression - C.virginica Gonad RNAseq Using Ballgown

  • 1 min read

In preparation for differential transcript analysis, I previously ran our RNAseq data through StringTie on 20210726 to identify and quantify transcripts. Identification of differentially expressed transcripts (DETs) and genes (DEGs) will be performed using ballgown. This notebook entry will be different than most others, as this notebook entry will simply serve as a “landing page” to access/review the analysis; as the analysis will evolve over time and won’t exist as a single computing job with a definitive endpoint.

Read More

Assembly Indexing - C.bairdi Transcriptome cbai_transcriptome_v3.1.fasta with Hisat2 on Mox

  • 2 min read

We recently received reviews back for the Tanner crab paper submission (“Characterization of the gene repertoire and environmentally driven expression patterns in Tanner crab (Chionoecetes bairdi)”) and one of the reviewers requested a more in-depth analysis. As part of addressing this, we’ve decided to identify SNPs withing the _Chionoecetes bairdi (Tanner crab) transcriptome used in the paper (cbai_transcriptome_v3.1). Since the process involves aligning sequencing reads to the transcriptome, the first thing that needed to be done was to generate index files for the aligner (HISAT2, in this particular case), so I ran HISAT2 on Mox.

Read More

Computer Management - Disable Sleep and Hibernation on Raven

  • ~1 min read

We’ve been having an issue with our computer Raven where it would become inaccessible after some time after a reboot. Attempts to remote in would just indicate no route to host or something like that. We realized it seemed like this was caused by a power saving setting, but changing the sleep setting in the Ubuntu GUI menu didn’t fix the issue. It also seemd like the sleep/hibernate issue was only a problem after the computer had been rebooted and no one had logged in yet…

Read More

Genome Analysis - Identification of Potential Contaminating Sequences in Panopea-generosa-v1.0 Assembly Using BlobToolKit on Mox

  • 6 min read

As part of our Panopea generosa (Pacific geoduck) genome sequencing efforts, Steven came across a tool designed to help identify if there are any contaminating sequences in your assembly. The software is BlobToolKit. The software is actually a complex pipeline of separate tools ([minimap2])https://github.com/lh3/minimap2, BLAST, DIAMOND BLAST, and BUSCO) which aligns sequencing reads and assigns taxonomy to the reads, as well as marking regions of the assembly with various taxonomic assignments.

Read More

Genome Assembly - Olurida_v090 with BGI Illumina and PacBio Hybrid Using Wengan on Mox

  • 3 min read

I was recently tasked with adding annotations for our Ostrea lurida genome assembly to NCBI. As it turns out, adding just annotation files can’t be done since the genome was initially submitted to ENA. Additionally, updating the existing ENA submission with annotations is not possible, as it requires a revocation of the existing genome assembly; requiring a brand new submission. With that being the case, I figured I’d just make a new genome submission with the annotations to NCBI. Unfortunately, there were a number of issues with our genome assembly that were going to require a fair amount of work to resolve. The primary concern was that most of the sequences are considered “low quality” by NCBI (too many and too long stretches of Ns in the sequences). Revising the assembly to make it compatible with the NCBI requirements was going to be too much, so that was abandoned.

Read More

Trimming - O.lurida BGI FastQs with FastP on Mox

  • 3 min read

After attempting to submit our Ostrea lurida (Olympia oyster) genome assembly annotations (via GFF) to NCBI, the submission process also highlighted some short comings of the Olurida_v081 assembly. When getting ready to submit the genome annotations to NCBI, I was required to calculate the genome coverage we had. NCBI suggested to calculate this simply by counting the number of bases sequenced and divide it by the genome size. Doing this resulted in an estimated coverage of ~55X coverage, yet we have significant stretches of Ns throughout the assembly. I understand why this is still technically possible, but it’s just sticking in my craw. So, I’ve decided to set up a quick assembly to see what I can come up with. Of note, the canonical assembly we’ve been using relied on the scaffolded assembly provided by BGI; we never attempted our own assembly from the raw data.

Read More

Genome Submission - Validation of Olurida_v081.fa and Annotated GFFs Prior to Submission to NCBI

  • 3 min read

Per this GitHub Issue, Steven has asked to get our Ostrea lurida (Olympia oyster) genome assembly (Olurida_v081.fa) submitted to NCBI with annotations. The first step in the submission process is to use the NCBI table2asn_GFF software to validate the FastA assembly, as well as the GFF annotations file. Once the software has been run, it will point out any errors which need to be corrected prior to submission.

Read More

Read Mapping - 10x-Genomics Trimmed FastQ Mapped to P.generosa v1.0 Assembly Using Minimap2 for BlobToolKit on Mox

  • 2 min read

To continue towards getting our Panopea generosa (Pacific geoduck) genome assembly (v1.0) analyzed with BlobToolKit, per this GitHub Issue, I’ve decided to run each aspect of the pipeline manually, as I continue to have issues utilizing the automatic pipeline. As such, I’ve run minimap2 according to the BlobToolKit “Getting Started” guide on Mox. This will map the trimmed 10x-Genomics reads from 20210401 to the Panopea-generosa-v1.0.fa assembly (FastA; 914MB).

Read More

Back to Top ↑

2020

Transcriptome Comparisons - C.bairdi Transcriptomes Evaluations with DETONATE rsem-eval on Mox

  • 5 min read

UPDATE: I’ll lead in with the fact that this failed with an error message that I can’t figure out. This will save the reader some time. I’ve posted the problem as an Issue on the DETONATE GitHub repo, however it’s clear that this software is no longer maintained, as the repo hasn’t been updated in >3yrs; even lacking responses to Issues that are that old.

Read More

Alignments - C.bairdi RNAseq Transcriptome Alignments Using Bowtie2 on Mox

  • 5 min read

I had previously attempted to compare all of our C.bairdi transcriptome assemblies using DETONATE on 20200601, but, due to hitting time limits on Mox, failed to successfully get the analysis to complete. I realized that the limiting factor was performing FastQ alignments, so I decided to run this step independently to see if I could at least get that step resolved. DETONATE (rsem-eval) will accept BAM files as input, so I’m hoping I can power through this alignment step and then provided DETONATE (rsem-eval) with the BAM files.

Read More

FastQC-MultiQc - C.gigas Ploidy pH WGBS Raw Sequence Data from Haws Lab on Mox

  • 2 min read

Yesterday (20201205), we received the whole genome bisulfite sequencing (WGBS) data back from ZymoResearch from the 24 C.gigas diploid/triploid subjected to two different pH treatments (received from the Haws’ Lab on 20200820 that we submitted to ZymoResearch on 20200824. As part of our standard sequencing data receipt pipeline, I needed to generate FastQC files for each sample.

Read More

Sample Submission - M.magister MBD BSseq Libraries for MiSeq at NOAA

  • 1 min read

Earlier today I quantified the libraries with the Qubit in preparation for sample pooling and sequencing. Before performing a full sequencing run, Mac wanted to select a subset of the libraries based on the experimental treatments to have an equal representation of samples. She also wanted to do a quick run on the MiSeq at NOAA to evaluate how well libraries map and to make sure libraries appear to be sequencing at relatively equal levels.

Read More

Transcriptome Assessment - Crustacean Transcripome Completeness Evaluation Using BUSCO on Mox

  • 4 min read

Grace was recently working on writing up a manuscript which did a basic comparison of our C.bairdi transcriptome (cbai_transcriptome_v3.1) (see the Genomic Resources wiki for more deets) to two other species’ transcriptome assemblies. We wanted BUSCO evaluations as part of this comparison, but the two other species did not have BUSCO scores in their respective publications. As such, I decided to generate them myself, as BUSCO runs very quickly. The job was run on Mox.

Read More

Hard Drive Upgrade - Gannet Synology Server

  • ~1 min read

Completed upgrading the 12 x 8TB HDDs in our server, Gannet (Synology RS3618XS), to 12 x 16TB HDDs. The process was simple, but the repair process took ~20hrs for each new drive. So, the entire process required 12 separate days of pulling out one old HDD, replacing with a new HDD, and initiating the repair process in the Synology web interface.

Read More

MBD Selection - M.magister Sheared Gill gDNA 16 of 24 Samples Set 3 of 3

  • 1 min read

Click here for notebook on the first eight samples processed. Click here for the second set of eight samples processed. M.magister (Dungeness crab) gill gDNA provided by Mackenzie Gavery was previously sheared on 20201026 and three samples were subjected to additional rounds of shearing on 20201027, in preparation for methyl bidning domain (MBD) selection using the MethylMiner Kit (Invitrogen).

Read More

Trimming - Shelly S.salar RNAseq Using fastp and MultiQC on Mox

  • 3 min read

Shelly asked that I trim, align to a genome, and perform transcriptome alignment counts in this GitHub issue with some Salmo salar RNAseq data she had and, using a subset of the NCBI Salmo salar RefSeq genome, GCF_000233375.1. She created a subset of this genome using only sequences designated as “chromosomes.” A link to the FastA (and a link to her notebook on creating this file) are in that GitHub issue link above. The transcriptome she has provided has not been subsetted in a similar fashion; maybe I’ll do that prior to alignment.

Read More

DNA Shearing - M.magister CH05-21 gDNA Full Shearing Test and Bioanalyzer

  • 2 min read

Yesterday, I did some shearing of Metacarcinus magister gill gDNA on a test sample (CH05-21) to determine how many cycles to run on the sonicator (Bioruptor 300; Diagenode) to achieve an average fragment length of ~350 - 500bp in preparation for MBD-BSseq. The determination from yesterday was 70 cycles (30s ON, 30s OFF; low intensity). That determination was made by first sonicating for 35 cycles, followed by successive rounds of 5 cycles each. I decided to repeat this, except by doing it in a single round of sonication.

Read More

DNA Shearing - M.magister gDNA Shear Testing and Bioanalyzer

  • 1 min read

Steven assigned me to do some MBD-BSseq library prep (GitHub Issue) for some Dungeness crab (Metacarcinus magister) DNA samples provided by Mackenzie Gavery. The DNA was isolated from juvenile (J6/J7 developmental stages) gill tissue. One of the first steps in MBD-BSseq is to fragment DNA to a desired size (~350 - 500bp in our case). However, we haven’t worked with Metacarcinus magister DNA previously, so I need to empirically determine sonicator (Bioruptor 300; Diagenode) settings for these samples.

Read More

Read Mapping - C.bairdi 201002558-2729-Q7 and 6129-403-26-Q7 Taxa-Specific NanoPore Reads to cbai_genome_v1.01.fasta Using Minimap2 on Mox

  • 2 min read

After extracting FastQ reads using seqtk on 20201013 from the various taxa I had been interested in, the next thing needed doing was mapping reads to the cbai_genome_v1.01 “genome” assembly from 20200917. I found that Minimap2 will map long reads (e.g. NanoPore), in addition to short reads, so I decided to give that a rip.

Read More

Data Wrangling - C.bairdi NanoPore Reads Extractions With Seqtk on Mephisto

  • 1 min read

In my pursuit to identify which contigs/scaffolds of our C.bairdi” genome assembly from 20200917 correspond to interesting taxa, based on taxonomic assignments produced by MEGAN6 on 20200928, I used MEGAN6 to extract taxa-specific reads from cbai_genome_v1.01 on 20201007 - the output is only available in FastA format. Since I want the original reads in FastQ format, I will use the FastA sequence IDs (from the FastA index file) and provide that to seqtk to extract the FastQ reads for each sample and corresponding taxa.

Read More

Taxonomic Assignments - C.bairdi 6129-403-26-Q7 NanoPore Reads Using DIAMOND BLASTx on Mox and MEGAN6 daa2rma on emu

  • 3 min read

After noticing that the initial MEGAN6 taxonomic assignments for our combined C.bairdi NanoPore data from 20200917 revealed a high number of bases assigned to E.canceri and Aquifex sp., I decided to explore the taxonomic breakdown of just the individual samples to see which of the samples was contributing to these taxonomic assignments most.

Read More

Taxonomic Assignments - C.bairdi 20102558-2729-Q7 NanoPore Reads Using DIAMOND BLASTx on Mox and MEGAN6 daa2rma on emu

  • 3 min read

After noticing that the initial MEGAN6 taxonomic assignments for our combined C.bairdi NanoPore data from 20200917 revealed a high number of bases assigned to E.canceri and Aquifex sp., I decided to explore the taxonomic breakdown of just the individual samples to see which of the samples was contributing to these taxonomic assignments most.

Read More

Data Wrangling - C.bairdi NanoPore 6129-403-26 Quality Filtering Using NanoFilt on Mox

  • 2 min read

Last week, I ran all of our Q7-filtered C.baird NanoPore reads through MEGAN6 to evaluate the taxonomic breakdown (on 20200917) and noticed that there were a large quantity of bases assigned to E.canceri (a known microsporidian agent of infection in crabs) and Aquifex sp. (a genus of thermophylic bacteria), in addition to the expected Arthropoda assignments. Notably, Alveolata assignments were remarkably low.

Read More

Data Wrangling - C.bairdi NanoPore 20102558-2729 Quality Filtering Using NanoFilt on Mox

  • 2 min read

Last week, I ran all of our Q7-filtered C.baird NanoPore reads through MEGAN6 to evaluate the taxonomic breakdown (on 20200917) and noticed that there were a large quantity of bases assigned to E.canceri (a known microsporidian agent of infection in crabs) and Aquifex sp. (a genus of thermophylic bacteria), in addition to the expected Arthropoda assignments. Notably, Alveolata assignments were remarkably low.

Read More

Data Wrangling - Subsetting cbai_genome_v1.0 Assembly with faidx

  • 1 min read

Previously assembled cbai_genome_v1.0.fasta with our NanoPore Q7 reads on 20200917 and noticed that there were numerous sequences that were well shorter than the expected 500bp threshold that the assembler (Flye) was supposed to spit out. I created an Issue on the Flye GitHub page to find out why. The developer responded and determined it was an issue with the assembly polisher and that sequences <500bp could be safely ignored.

Read More

DNA Quantification - Re-quant Ronits C.gigas Diploid-Triploid Ctenidia gDNA Submitted to ZymoResearch

  • 1 min read

I received notice from ZymoResearch yesterday afternoon that the DNA we sent on 20200820 for this project (Quote 3534) had insufficient DNA for sequencing for most of the samples. This was, honestly, shocking. I had even submitted well over the minimum amount of DNA required (submitted 1.75ug - only needed 1ug). So, I’m not entirely sure what happened here.

Read More

Primer Design and In-Silico Testing - Geoduck Reproduction Primers

  • 1 min read

Shelly asked that I re-run the primer design pipeline that Kaitlyn had previously run to design a set of reproduction-related qPCR primers. Unfortunately, Kaitlyn’s Jupyter Notebook wasn’t backed up and she accidentally deleted it, I believe, so there’s no real record of how she designed the primers. However, I do know that she was unable to run the EMBOSS primersearch tool, which will check your primers against a set of sequences for any other matches. This is useful for confirming specificity.

Read More

Metagenomics - Data Extractions Using MEGAN6

  • 1 min read

Decided to finally take the time to methodically extract data from our metagenomics project so that I have the tables handy when I need them and I can easily share them with other people. Previously, I hadn’t done this due to limitations on looking at the data remotely. I finally downloaded all of the RMA6 files from 20191014 after being fed up with the remote desktop connection and upgrading the size of my hard drive (5 of the six RMA6 files are >40GB in size).

Read More

Sequence Extractions - C.bairdi Transcriptomes v2.0 and v3.0 Excluding Alveolata with MEGAN6 on Swoose

  • ~1 min read

Continuing to try to identify the best C.bairdi transcriptome, we decided to extract all non-dinoflagellate sequences from cbai_transcriptome_v2.0 (RNAseq shorthand: 2018, 2019, 2020-GW, 2020-UW) and cbai_transcriptome_v3.0 (RNAseq shorthand: 2018, 2019, 2020-UW). Both of these transcriptomes were assembled without any taxonomic filter applied. DIAMOND BLASTx and conversion to MEGAN6 RMA6 files was performed yesterday (20200604).

Read More

Transcriptome Comparison - C.bairdi Transcriptomes Compared with DETONATE on Mox

  • 4 min read

We’ve produced a number of C.bairdi transcriptomes and we’re interested in doing some comparisons to try to determine which one might be “best”. I previously compared the BUSCO scores of each of these transcriptomes and now will be using the DETONATE software package to perform two different types of comparisons: compared to a reference (REF-EVAL) and determine an overall quality “score” (RSEM-EVAL). I’ll be running REF-EVAL in this notebook.

Read More

Transcriptome Assembly - C.bairdi All Pooled Arthropoda-only RNAseq Data with Trinity on Mox

  • 2 min read

For completeness sake, I wanted to create an additional C.bairdi transcriptome assembly that consisted of Arthropoda only sequences from just pooled RNAseq data (since I recently generated a similar assembly without taxonomically filtered reads on 20200518). This constitutes samples we have designated: 2018, 2019, 2020-UW. A de novo assembly was run using Trinity on Mox. Since all pooled RNAseq libraries were stranded, I added this option to Trinity command.

Read More

Transcriptome Assembly - P.trituberculatus (Japanese blue crab) NCBI SRA BioProject PRJNA597187 Data with Trinity on Mox

  • 3 min read

After generating a number of C.bairdi (Tanner crab) transcriptomes, we decided we should compare them to evaluate which to help decide which one should become our “canonical” version. As part of that, the Trinity wiki offers a list of tools that one can use to check the quality of transcriptome assemblies. Some of those require a transcriptome of a related species.

Read More

SRA Library Assessment - Determine RNAseq Library Strandedness from P.trituberculatus SRA BioProject PRJNA597187

  • 3 min read

We’ve produced a number of C.bairid transcriptomes utilizing different assembly approaches (e.g. Arthropoda reads only, stranded libraries only, mixed strandedness libraries, etc) and we want to determine which of them is “best”. Trinity has a nice list of tools to assess the quality of transcriptome assemblies, but most of the tools rely on comparison to a transcriptome of a related species.

Read More

Transcriptome Assembly - C.bairdi All Pooled RNAseq Data Without Taxonomic Filters with Trinity on Mox

  • 2 min read

Steven asked that I assemble a transcriptome with just our pooled C.bairdi RNAseq data (not taxonomically filtered; see the FastQ list file linked in the Results section below). This constitutes samples we have designated: 2018, 2019, 2020-UW. A de novo assembly was run using Trinity on Mox. Since all pooled RNAseq libraries were stranded, I added this option to Trinity command.

Read More

GO to GOslim - C.bairdi Enriched GO Terms from 20200422 DEGs

  • 6 min read

After running pairwise comparisons and identify differentially expressed genes (DEGs) on 20200422 and finding enriched gene ontology terms, I decided to map the GO terms to Biological Process GOslims. Additionally, I decided to try another level of comparison (I’m not sure how valid it is), whereby I will count the number of GO terms assigned to each GOslim and then calculate the percentage of GOterms that get assigned to each of the GOslim categories. The idea being that it might help identify Biological Processes that are “favored” in a given set of DEGs. I decided to set up “fancy” pyramid plots to view a given set of GO-GOslims for each DEG comparison.

Read More

NanoPore Sequencing - C.bairdi gDNA 6129_403_26

  • 1 min read

After getting high quality gDNA from Hematodinium-infected C.bairdi hemolymph on 2020210 we decided to run some of the sample on the NanoPore MinION, since the flowcells have a very short shelf life. Additionally, the results from this will also help inform us on whether this sample might worth submitting for PacBio sequencing. And, of course, this provides us with additional sequencing data to complement our previous NanoPore runs from 20200109.

Read More

qPCR - C.bairdi RNA Check for Residual gDNA

  • 1 min read

Previuosly checked existing crab RNA for residual gDNA on 20200226 and identified samples with yields that were likely too low, as well as samples with residual gDNA. For those samples, was faster/easier to just isolate more RNA and perform the in-column DNase treatment in the ZymoResearch Quick DNA/RNA Microprep Plus Kit; this keeps samples concentrated. So, I isolated more RNA on 20200306 and now need to check for residual gDNA.

Read More

Trimming/MultiQC - Methcompare Bisulfite FastQs with fastp on Mox

  • 3 min read

Steven asked me to trim a set of FastQ files, provided by Hollie Putnam, in preparation for methylation analysis using Bismark. The analysis is part of a coral project comparing DNA methylation profiles of different species, as well as comparing different sample prep protocols. There’s a dedicated GitHub repo here:

Read More

RNA Isolation and Quantification - C.bairdi RNA from Hemolymph Pellets in RNAlater

  • ~1 min read

Based on qPCR results testing for residual gDNA from 20200225, a set of 24 samples were identified that required DNase treatment and/or additional RNA. I opted to just isolate more RNA from all samples, since the kit includes a DNase step and avoids diluting the existing RNA using the Turbo DNA-free Kit that we usully use. Isolated RNA using the Quick DNA/RNA Microprep Kit (ZymoResearch; PDF) according to the manufacturer’s protocol for liquids/cells in RNAlater.

Read More

DNA Isolation, Quantification, and Gel - C.bairdi gDNA Sample 6129_403_26

  • 1 min read

In order to do some genome sequencing on C.bairid and Hematodinium, we need hihg molecular weight gDNA. I attempted this twice before, using two different methods (Quick DNA/RNA Microprep Kit (ZymoResearch) on 20200122 and the E.Z.N.A Mollusc DNA Kit (Omega) on 20200108) using ~10yr old ethanol-preserved tissue provided by Pam Jensen. Both methods yielded highly degrade gDNA. So, I’m now attempting to get higher quality gDNA from the RNAlater-preserved hemolymph pellets from this experiment.

Read More

Gene Expression - Hematodinium MEGAN6 with Trinity and EdgeR

  • 2 min read

After completing annotation of the Hematodinium MEGAN6 taxonomic-specific Trinity assembly using Trinotate on 20200126, I performed differential gene expression analysis and gene ontology (GO) term enrichment analysis using Trinity’s scripts to run EdgeR and GOseq, respectively. The comparison listed below is the only comparison possible, as there were no reads present in the uninfected Hematodinium extractions.

Read More

Gene Expression - C.bairdi MEGAN6 with Trinity and EdgeR

  • 2 min read

After completing annotation of the C.bairdi MEGAN6 taxonomic-specific Trinity assembly using Trinotate on 20200126, I performed differential gene expression analysis and gene ontology (GO) term enrichment analysis using Trinity’s scripts to run EdgeR and GOseq, respectively, across all of the various treatment comparisons. The comparison are listed below and link to each individual SBATCH script (GitHub) used to run these on Mox.

Read More

RNA Isolation and Quantification - C.bairdi Hemocyte Pellets in RNAlater Troubleshooting

  • 1 min read

After the failure to obtain RNA from any C.bairdi hemocytes pellets (out of 24 samples processed) on 20200117, I decided to isolate RNA from just a subset of that group to determine if I screwed something up last time or something. Also, I am testing two different preparations of the kit-supplied DNase I: one Kaitlyn prepped and a fresh preparation that I made. Admittedly, I’m not doing the “proper” testing by trying the different DNase preps on the same exact sample, but it’ll do. I just want to see if I get some RNA from these samples this time…

Read More

NanoPore Sequencing - Initial NanoPore MinION Lambda Sequencing Test

  • 1 min read

We recently acquired a NanoPore MinION sequencer, FLO-MIN106 flow cell and the Rapid Sequencing Kit (SQK-RAD004). The NanoPore website provides a pretty thorough an user-friendly walk-through of how to begin using the system for the first time. With that said, I believe the user needs to have a registered account with NanoPore and needs to have purchased some products to have full access to the protocols they provide.

Read More

Back to Top ↑

2019

Trimming/FastQC/MultiQC - C.bairdi RNAseq FastQ with fastp on Mox

  • 2 min read

Grace/Steven asked me to generate a de novo transcriptome assembly of our current C.bairdi RNAseq data in this GitHub issue. As part of that, I needed to quality trim the data first. Although I could automate this as part of the transcriptome assembly (Trinity has Trimmomatic built-in), I would be unable to view the post-trimming results until after the assembly was completed. So, I opted to do the trimming step separately, to evaluate the data prior to assembly.

Read More

Data Wrangling - Rename Pgenerosa_v074 Files and Scaffolds

  • ~1 min read

Continuing to organizing files for a manuscript dealing with the geoduck genome assembly/annotation we’ve done, we decided to rename the files as well as rename the scaffolds, to make the naming consistent and a bit easier to read (both for humans and computers).

Read More

Data Wrangling - Splitting BAM by Size for Upload to OSF

  • ~1 min read

We’re in the process of organizing files for a manuscript dealing with the geoduck genome assembly/annotation we’ve done. As part of that, we need the Stringtie BAM file that was used with GenSAS for Pgenerosa_v074 annotation to upload to the Open Science Foundation repository for this project. Unfortunately, at 73GB, the file far exceeds the individual file size limit for OSF (5GB). So, I split it into 5GB chunks. See the following notebook for deets:

Read More

Data Wrangling - Panopea generosa Genome Feature Sequence Lengths

  • 1 min read

In preparation for a paper we’re writing, we needed some summary stats on the various genome assembly feature sequences. I determined the max/min, mean, and median sequence lengths for all the GFF feature files we currently have for Pgenerosa_v070, Pgenerosa_v070_top18_scaffolds, and Pgenerosa_v074. This info will be compiled in to a table for the manuscript. See our Genomic Resources wiki for more info on GFFs:

Read More

Genome Comparison - Pgenerosa_v074 vs Pgenerosa_v070 with MUMmer Promer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer 3.23 (specifically, promer for protein level comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs S.glomerata NCBI with MUMmer Promer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer 3.23 (specifically, promer for protein level comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs M.yessoensis NCBI with MUMmer Promer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer 3.23 (specifically, promer for protein level comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs H.sapiens NCBI with MUMmer Promer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer 3.23 (specifically, promer for protein level comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs C.virginica NCBI with MUMmer Promer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer 3.23 (specifically, promer for protein level comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs C.gigas NCBI with MUMmer Promer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer 3.23 (specifically, promer for protein level comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs Pgenerosa_v070 with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs Pgenerosa_v074 with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs S.glomerata NCBI with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs M.yessoensis NCBI with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs H.sapiens NCBI with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs C.gigas NCBI with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Genome Comparison - Pgenerosa_v074 vs C.virginica NCBI with MUMmer on Mox

  • 3 min read

In continuing to further improve our geoduck genome annotation, I’m attempting to figure out why Scaffold 1 of our assembly doesn’t have any annotations. As part of that I’ve decided to perform a series of genome comparisons and see how they match up, with an emphasis on Scaffold 1, using MUMmer (v4) (specifically, nucmer for nucleotide comparisons). This software is specifically designed to do this type of comparison.

Read More

Data Summary - P.generosa Transcriptome Assemblies Stats

  • 1 min read

In our continuing quest to wrangle the geoduck transcriptome assemblies we have, I was tasked with compiling assembly stats for our various assemblies. The table below provides an overview of some stats for each of our assemblies. Links within the table go to the the notebook entries for the various methods from which the data was gathered. In general:

Read More

Genome Annotation - Pgenerosa_v074 Transcript Isoform ID with Stringtie on Mox

  • 4 min read

After annotating Pgenerosa_v070 and comparing feature counts, there was a drastic difference between the two genome versions. Additionally, both of those genomes ended up with no CDS/exon/gene/mRNA features identified in the largest scaffold. So, to explore this further by seeing where (if??) sequencing reads map to the scaffold, and to obtain transcript isoforms for the genome, I ran Stringtie. A Hisat2 index was prepared earlier.

Read More

Genome Annotation - Pgenerosa_v070 Transcript Isoform ID with Stringtie on Mox

  • 3 min read

After annotating Pgenerosa_v074 and comparing feature counts, there was a drastic difference between the two genome versions. Additionally, both of those genomes ended up with no CDS/exon/gene/mRNA features identified in the largest scaffold. So, to explore this further by seeing where (if??) sequencing reads map to the scaffold, and to obtain transcript isoforms for the genome, I ran Stringtie. A Hisat2 index was prepared earlier.

Read More

Genome Annotation - Pgenerosa_v070 and v074 Top 18 Scaffolds Feature Count Comparisons

  • 1 min read

After annotating Pgenerosa_v074 on 20190701, we noticed a large discrepancy in the number of transcripts that MAKER identified, compared to Pgenerosa_v070. As a reminder, the Pgenerosa_v074 is a subset of Pgenerosa_v070 containing only the top 18 longest scaffolds. So, we decided to do a quick comparison of the annotations present in these 18 scaffolds Pgenerosa_v070 and Pgenerosa_v074.

Read More

Genome Annotation - Pgenerosa_v071 Using GenSAS

  • 3 min read

In our various attempts to get the Panopea generosa genome annotated in such a manner that we’re comfortable with (the previous annotation attempts we’re lacking any annotations in almost all of the largest scaffolds, which didn’t seem right), Steven stumbled across GenSAS, a web/GUI-based genome annotation program, so we gave it a shot.

Read More

Genome Annotation - Pgenerosa_v074 Using GenSAS

  • 4 min read

In our various attempts to get the Panopea generosa genome annotated in such a manner that we’re comfortable with (the previous annotation attempts we’re lacking any annotations in almost all of the largest scaffolds, which didn’t seem right), Steven stumbled across GenSAS, a web/GUI-based genome annotation program, so we gave it a shot.

Read More

Genome Annotation - Olurida_v081 with MAKER and Tissue-specific Transcriptomes on Mox

  • 10 min read

I previously annotated our Olurida_v081 genome with MAKER using our “canonical” transcriptome, Olurida_transcriptome_v3.fasta as the EST evidence utilized by MAKER. A discussion on one of our Slack channels related to the lack of isoform annotation (I think it’s a private channel, sorry) prompted Katherine Silliman to suggest re-running the annotation using tissue-specific transcriptome assemblies that she has generated as EST evidence, instead of a singular transcriptome. Since I already had previous versions of the MAKER script that I’ve used for annotations, re-running was rather straightforward. While this was running, I used Stringtie on 20190625to produce a GTF that maps out potential isoforms, as I don’t believe MAKER will actually predict isoforms, since it didn’t do so the first time, nor has it with other annotations we’ve run on geoduck assemblies.

Read More

FastQC-MultiQC - Additional C.gigas WGBS Sequencing Data from Genewiz Received 20190501

  • ~1 min read

Earlier today, we received the additional G.gigas sequencing data from Genewiz. Wanted to run through FastQC again and get an updated report for each data set. Admittedly, it probably won’t look much different from the initial FastQC run on 20190415, due to the fact that the additional sequencing was simply appended to the previous data. Since FastQC examines a subset of the data in each file, I’d fully expect the FastQC report to look the same. However, we’ll have a greater number of sequences in each file. This should, in turn, increase the number of reads retained after quality trimming.

Read More

Data Analysis - C.virginica MBD Sequencing Coverage

  • 2 min read

A while ago, Steven tasked me with assessing some questions related to the sequencing coverage we get doing MBD-BSseq in this GitHub issue. At the heart of it all was really to try to get an idea of how much usable data we actually get when we do an MBD-BSseq project. Yaamini happened to have done an MBD-BSseq project relatively recently, and it’s one she’s actively working on analyzing, so we went with that data set.

Read More

Metagenomics Gene Prediction - P.generosa Water Samples Using MetaGeneMark on Mox to Compare pH Treatments

  • 2 min read

Continuing with a relatively quick comparison of pH treatments (pH=7.1 vs. pH=8.2), I wanted to run gene prediction on the MEGAHIT assemblies I made yesterday. I ran MetaGeneMark on the two pH-specific assemblies on Mox. This should be a very fast process (I’m talking, like a couple of minutes fast), so it enhances the annotation with very little effort and time.

Read More

Metagenome Assemblies - P.generosa Water Samples Trimmed HiSeqX Data Using Megahit on Mox to Compare pH Treatments

  • 2 min read

A report involving our work on the geoduck water metagenomics is due later this week and our in-depth analysis for this project using Anvi’o is likely to require at least another week to complete. Even though we have a broad overview of the metagenomic taxa present in these water samples, we don’t have data in a format for comparing across samples/treatments. So, I initiated our simplified pipeline (MEGAHIT > MetaGeneMark > BLASTn > KronaTools) for examining our metagenomic data of the two treatments:

Read More

RNA Isolation and Quantification - Crab Hemolypmh Using Quick-DNA-RNA Microprep Plus Kit

  • 1 min read

In the continuing struggle to isolate RNA from the Chionoecetes bairdi hemolymph preserved in RNAlater, Pam managed to find the Quick-DNA-RNA Microprep Plus Kit (ZymoResearch) as a potential option. We received a free sample of the kit and so I gave it a shot. Grace pulled 10 samples she’d previously used to isolate RNA (and was unable to get anything out of virtually all of them using the RNeasy Plus Micro Kit (Qiagen)) for me to try out this new kit:

Read More

Transcriptome Assembly - Geoduck Tissue-specific Assembly Larvae Day5 EPI99 with HiSeq and NovaSeq Data on Mox

  • 2 min read

I previously assembled and annotated P.generosa larval Day 5 transcriptome (20190318 - mislabeled as Juvenile Day 5 in my previous notebook entries) using just our HiSeq data from our Illumina collaboration. This was a an oversight, as I didn’t realize that we also had NovaSeq RNAseq data. So, I’ve initiated another de novo assembly using Trinity incorporating both sets of data.

Read More

Data Management - Data Migration and Drive Expansion on Gannet

  • 1 min read

A little while ago, we installed some additional hard drives in Gannet (Synology RS3618XS) with the intention of expanding the total storage space. However, the original set of HDDs were set up as RAID10. As it turns out, RAID10 configurations cannot be expanded! So, the new set of HDDs were configured as a separate volume (Volume 2) in a RAID6 configuration. After backing up the /volume1/web directory (via rsync) to our UW Google Drive, I begane the data migration.

Read More

Genome Assessment - BUSCO Metazoa on P.generosa v071 on Mox

  • 6 min read

Ran BUSCO on our completed annotation of the P.generosa v071 genome (GFF) (subset of sequences >10kbp). See this notebook entry for genome annotation info. This provides a nice metric on how “complete” a genome assembly (or transcriptome) is. Additionally, BUSCO is tied in with Augustus for gene prediction and generates ab initio gene models. With that said, since I just want to evaluate the completeness of this particular genome assembly, I’ll be using the annotated genome generated through two rounds of SNAP gene prediction. Otherwise, I’d use the initial MAKER annotations to generate an Augustus gene model that could be used in conjuction with the SNAP models (I’ll likely do this at a later date).

Read More

Genome Annotation - Pgenerosa_v070 MAKER on Mox

  • 7 min read

Here it goes, a massive undertaking of attempting to annotate the Pgenerosa_v070 genome (FastA; 2.1GB) using MAKER on Mox! I previously started this on 20190115, but killed it in order to fix a number of different issues with the script that were causing problems. I decided the changes were substantial enough, that I’d just make a new working directory and notebook entry.

Read More

Data Wrangling - CpG OE Calculations on C.virginica Genes

  • 2 min read

Steven tasked me with processing ~90 FastA files containing gene sequences from C.virginica in this GitHub Issue. He needed to determine the Observed/Expected (O/E) ratio of CpGs in each FastA. He provided this example code and this link to all the files. Additionally, today, he tasked Kaitlyn with merging all of the output CpG O/E values for each sample in to a single file, but I decided to tackle it anyway.

Read More

Methylation Analysis - C.virginica

  • 4 min read

This is a quick and dirty (i.e. no adaptor/quality trimming) assessment of all of our Crassostrea irginica bisulfite sequencing efforts to date in order to get a rough idea of the methylation mapping, per this GitHub issue. Ran Bismark on Mox on a series of subset of the reads:

Read More

DNA Isolation and Quantification - Ronit’s C.gigas Ploidy Ctenidia

  • ~1 min read

Last week, I isolated DNA from all of Ronti’s ctenidia samples, however one sample (D18-C) didn’t isolate properly. So, I performed another isolation procedure with another section of frozen tissue. Tissue was excised from frozen tissue block via razor blade (weight not recorded) and pulverized under liquid nitrogen. Samples were incubated O/N @ 37oC (heating block) in 350uL of MB1 Buffer + 25uL Proteinase K, per the E.Z.N.A. Mollusc DNA Kit (Omega) instructions.

Read More

Annotation - Olurida_v081 MAKER Proteins InterProScan5 on Mox

  • 1 min read

Continuation of genome annotation of the Olympia oyster genome. Determined initial gene models using MAKER with two rounds of SNAP, relabeled with more user-friendly names, and then performed protein-level annotations using BLASTp. Next, I’m going to run InterProScan5 (IPS5) to help functionally characterize the O.lurida proteins ID’d by MAKER. Once this is complete, I’ll use MAKER to incorporate the IPS5 and BLASTp results into a much more neatly (i.e. human-readable) annotated genome!

Read More

Back to Top ↑

2018

qPCR - Relative mitochondrial abundance in C.gigas diploids and triploids subjected to acute heat stress via COX1

  • 2 min read

Using the C.gigas cytochrome c oxidase (COX1) primers (SR IDs: 1713, 1714)I designed the other day, I ran a qPCR on a subset of Ronit’s diploid/triploid control/heat shocked oyster DNA that Shelly had previously isolated and performed global DNA methylation assay. The goal is to get a rough assessment of whether or not there appear to be differences in relative mitochondrial abundances between these samples.

Read More

FastQC and Trimming - Metagenomics (Geoduck) HiSeqX Reads from 20180809

  • 1 min read

Steven tasked me with assembling our geoduck metagenomics HiSeqX data. The first part of the process is examining the quality of the sequencing reads, performing quality trimming, and then checking the quality of the trimmed reads. It’s also possible (likely) that I’ll need to run another round of trimming. The process is documented in the Jupyter Notebook linked below. After these reads are cleaned up, I’ll transfer them over to our HPC nodes (Mox) and try assembling them.

Read More

Annotation - Olurida_v081 MAKER on Mox

  • 20 min read

Remarkably, I managed to burn through our Xsede computing resources and don’t have terribly much to show for it. Ooof! This is a major bummer, as it “only” takes ~8hrs for a WQ-MAKER job to run there, as opposed to months the last time I tried running it on Mox. Although we have used up our Xsede allocation, all is not lost! The experience of setting up/running WQ-MAKER has enlightened me on how it all works and how to run it on Mox so it will (hopefully) take far, far less time than the last Mox attempt. With that said, here we go…

Read More

Installation - Microsoft Machine Learning Server (Microsoft R Open) on Emu/Roadrunner R Studio Server

  • ~1 min read

Steven recently saw an announcement that Microsoft R Open now handles multi-threaded processing (default R does not), so we were interested in trying it out. I installed MLR/MRO on Emu/Roadrunner (Apple Xserve; Ubuntu 16.04). Followed the Microsoft installation directions for Ubuntu. In retrospect, I think I could’ve just installed MRO, but this gets the job done as well and won’t hurt anything.

Read More

Mox - Password-less SSH!

  • 1 min read

The high performance computing (HPC) cluster (called Mox) at Univ. of Washington (UW) frustratingly requires a password when SSH-ing, even when SSH keys are in use. I have a lengthy, unintelligible password that I use for my UW account, so having to type this in any time I want to initiate a new SSH session on Mox is a painful process.

Read More

Ubuntu - Fix “No Video Signal” Issue on Emu/Roadrunner

  • 1 min read

Both Apple Xserves (Emu/Roadrunner) running Ubuntu (16.04LTS) experienced the same issue - the monitor would indicate “No Video Signal”, would go dark, and wasn’t responsive to keyboard/mouse movements. However, you could ssh into both machines w/o issue.

Read More

Total Alkalinity Calculations - Yaamini’s Ocean Chemistry Samples

  • 1 min read

I ran a subset of Yaamini’s ocean chemistry samples on our T5 Excellence titrator (Mettler Toledo) at the beginning of April. The subset were samples taken from the beginning, middle, and end of the experiment. The rationale for this was to assess whether or not total alkalinity (TA) varied across the experiment. If there was little variation, then there’d likely be no need to run all of the samples. However, should there be temporal differences, then all samples should be processed.

Read More

Kmer Estimation - Kmergenie on Geoduck Sequence Data (default settings)

  • ~1 min read

After the last SparseAssembler assembly completed, I wanted to do another run with a different kmer size (last time was arbitrarily set at 101). However, I didn’t really know how to decide, particularly since this assembly consisted of mixed read lenghts (50bp and 100bp). So, I ran kmergenie on all of our geoduck (Panopea generosa) sequencing data in hopes of getting a kmer determination to apply to my next assembly.

Read More

Back to Top ↑

2017

Samples Submitted - Geoduck Tissues to Illumina for More 10x Genomics Sequencing

  • ~1 min read

Continuing Illumina’s generous efforts to use our geoduck samples to test out the robustness of their emerging sequencing technologies, they have requested we send them some more geoduck tissue so that they can try to isolate higher molecular weight DNA to complete the genome sequencing efforts using the 10x genomics sequencing platform.

Read More

FAIL - Missing Data on Owl!

  • 1 min read

Uh oh. There appears to be some data that’s been removed from Owl. I noticed this earlier when trying to look at some of Sean’s data. His data should be in a folder with his name in Owl/scaphapoda

Read More

Data Management - Convert Oly PacBio H5 to FASTQ

  • ~1 min read

After working with all of this Olympia oyster genome sequencing data, I remembered that we had an old, singular PacBio SMRT cell file (from June 2013). This file didn’t seem to be included in any recent assemblies of Sean’s or mine. This is most likely because we have it in the PacBio H5 format and not in FASTQ.

Read More

RNA Isolation - Olympia oyster gonad tissue in paraffin histology blocks

  • 1 min read

My previous go at this was a little premature - I didn’t wait for Laura to fully annotate her slides/blocks. Little did I know, the tissue was mostly visceral mass and, as such, I didn’t hit much in the way of actual gonad tissue. So, I’m redoing this, now that Grace has gone through and annotated the blocks to point out gonad tissue. SN-10-16 was sent to Katherine Silliman on 20170720.

Read More

RNA Isolation - Olympia oyster gonad tissue in paraffin histology blocks

  • 2 min read

UPDATE 20170712: The RNA I isolated below is from incorrect regions of tissue. I misunderstood exactly what this tissue was, and admittedly, jumped the gun. The tissue is actually collected from the visceral mass - which contains gonad (a small amount) and digestive gland (a large amount). The RNA isolated below will be stored in one of the Shellfish RNA boxes and I will isolate RNA from the correct regions indicated by Grace

Read More

Goals - June 2017

  • ~1 min read

Well, my previous goal was to tidy up an existing manuscript and get it re-submitted to PeerJ. That’s pretty much done, as Steven will be giving a final once over and formatting the rebuttal letter prior to resubmission.

Read More

Computing - Oly BGI GBS Reproducibility Fail

  • 2 min read

Since we’re preparing a manuscript that relies on BGI’s manipulation/handling of the genotype-by-sequencing data, I attempted to could reproduce the demultiplexing steps that BGI used in order to perform the SNP/genotyping on these samples.

Read More

FASTQC - Oly BGI GBS Raw Illumina Data Demultiplexed

  • ~1 min read

Last week, I ran the two raw FASTQ files through FastQC. As expected, FastQC detected “errors”. These errors are due to the presence of adapter sequences, barcodes, and the use of a restriction enzyme (ApeKI) in library preparation. In summary, it’s not surprising that FastQC was not please with the data because it’s expecting a “standard” library prep that’s already been trimmed and demultiplexed.

Read More

DNA Isolation - Geoduck gDNA for Illumina-initiated Sequencing Project

  • 1 min read

We were previously approached by Cindy Lawley (Illumina Market Development) for possible participation in an Illumina product development project, in which they wanted to have some geoduck tissue and DNA on-hand in case Illumina green-lighted the use of geoduck for testing out the new sequencing platform on non-model organisms. Well, guess what, Illumina has give the green light for sequencing our geoduck! However, they need at least 4μg of gDNA, so I’m isolating more.

Read More

Data Management - Replacement of Corrupt BGI Oly Genome FASTQ Files

  • ~1 min read

Previously, Sean and Steven identified two potentially corrupt FASTQ files. I contacted BGI about getting replacement files and they informed me that all versions of the FASTQ files they have delivered on three separate occasions are all the same file (despite having different file names). As such, I could use one of these versions to replace the corrupt FASTQ files. So, that’s what I did!

Read More

Goals - January 2017

  • 1 min read

One of the long-running goals I’ve had is to get this Oly GBS data taken care of and out the door to publication. I think I will finally succeed with this, with the help of Pub-A-Thon. Don’t get too excited, it’s not what you think. It is not the drinking extravaganza that the name implies. Instead, it’s a “friendly” lab competition to get some scientific publications assembled and submitted.

Read More

Back to Top ↑

2016

Data Management - Integrity Check of Final BGI Olympia Oyster & Geoduck Data

  • ~1 min read

After completing the downloads of these files from BGI, I needed to verify that the downloaded copies matched the originals. Below is a Jupyter Notebook detailing how I verified file integrity via MD5 checksums. It also highlights the importance of doing this check when working with large sequencing files (or, just large files in general), as a few of them had mis-matching MD5 checksums!

Read More

Goals - November 2016

  • ~1 min read

Well, I’m serious this time. My goal for this month is to complete the Oly GBS data analysis and, get the data sets and data analysis prepared/placed in satisfactory repositories in preparation for publication in Scientific Data.

Read More

Goals - October 2016

  • ~1 min read

Last month’s goals, as it turns out, were way too ambitious. This month’s goal will be to get the Oly GBS data analysis fully completed (currently have individuals data, but need summary of the three populations data). I’ll also get the data sets and data analysis prepared/placed in satisfactory repositories in preparation for publication in Scientific Data.

Read More

Data Received – Jay’s Coral epiRADseq - Not Demultiplexed

  • 1 min read

Previously downloaded Jay’s epiRADseq data that was provided by the Genomic Sequencing Laboratory at UC-Berkeley. It was provided already demultiplexed (which is very nice of them!). To be completionists on our end, we requested the non-demultiplexed data set.

Read More

Oyster Sampling - Olympia Oyster OA Populations at Manchester

  • 1 min read

I helped Katherine Silliman with her oyster sampling today from her ocean acidification experiment with Olympia oysters (Ostrea lurida) at the Kenneth K. Chew Center for Shellfish Research & Restoration, which is housed at the NOAA Northwest Fisheries Science Center at Manchester in a partnership with the [Puget Sound Restoration Fund (PSRF)(http://www.restorationfund.org/). We sampled the following tissues and stored in 1mL RNAlater:

Read More

Computing - Amazon EC2 Cost “Analysis”

  • 3 min read

I recently moved some computing jobs over to Amazon’s Elastic Cloud Computing (EC2) in attempt to avoid some odd computing issues/errors I kept encountering on our lab computers (Apple Xserve 3,1).

Read More

Goals - August 2016

  • ~1 min read
  • Complete Olympia oyster GBS data analysis - Progress has actually been made! After many struggles, I managed to get a PyRad analysis of the entire data set to complete. Now, I just have to figure out what to do with the output files…

Read More

Computing - Amazon EC2 Instance Out of Space?

  • ~1 min read

Running PyRad analysis on the Olympia oyster GBS data. PyRad exited with warnings about running out of space. However, looking at free disk space on the EC2 Instance suggests that there’s still space left on the disk. Possibly PyRad monitors the expected disk space usage during analysis to verify there will be sufficient disk space to write to? Regardless, will expand EC2 volume instance to a larger size…

Read More

Dissection - Frozen Geoduck & Pacific Oyster

  • 2 min read

We’re working on a project with Washington Department of Natural Resources’ (DNR) Micah Horwith to identify potential proteomic biomarkers in geoduck (Panopea generosa) and  Pacific oyster (Crassostrea gigas). One aspect of the project is how to best conduct sampling of juvenile geoduck (Panopea generosa) and Pacific oyster (Crassostrea gigas) to minimize changes in the proteome of ctenidia tissue during sampling. Generally, live animals are shucked, tissue dissected, and then the tissue is “snap” frozen. However, Micah’s crew will be collecting animals from wild sites around Puget Sound and, because of the remote locations and the means of collection, will have limited tools and time to perform this type of sampling. Time is a significant component that will have great impact on proteomic status in each individual.

Read More

Docker - Improving Roberts Lab Reproducibility

  • 2 min read

In an attempt at furthering our lab’s abilities to maximize our reproducibility, I’ve been  working on developing an all-encompassing Docker image. Docker is a type of virtual machine (i.e. a self-contained computer that runs within your computer). For the Roberts Lab, the advantage of using Docker is that the Docker images can be customized to run a specific suite of software and these images can then be used by any other person in the lab (assuming they can run Docker on their particular operating system), regardless of operating system. In turn, if everyone is using the same Docker image (i.e. the same virtual machine with all the same software), then we should be able to reproduce data analyses more reliably, due to the fact that there won’t be differences between software versions that people are using. Additionally, using Docker greatly simplifies the setup of new computers with the requisite software.

Read More

Data Analysis - Oly GBS Data Using Stacks 1.37

  • ~1 min read

This analysis ran (or, more properly, was attempted) for a couple of weeks and failed a few times. The failures seemed to be linked to the external hard drive I was reading/writing data to. It continually locked up, leading to “Segmentation fault” errors.

Read More

Goals - May 2016

  • ~1 min read

Well, I guess the first goal is to remember to be more consistent about writing monthly goals…

Read More

Data Management - O.lurida Raw BGI GBS FASTQ Data

  • ~1 min read

BGI had previously supplied us with demultiplexed GBS FASTQ files. However, they had not provided us with the information/data on how those files were created. I contacted them and they’ve given us the two original FASTQ files, as well as the library index file and corresponding script they used for demultiplexing all of the files. The Jupyter (iPython) notebook below updates our checksum and readme files in our server directory that’s hosting the files: http://owl.fish.washington.edu/nightingales/O_lurida/20160223_gbs/

Read More

Data Analysis - Oly GBS Data from BGI Using Stacks

  • ~1 min read

UPDATE (20160418) : I’m posting this more for posterity, as Stacks continually locked up at both the “ustacks” and “cstacks” stages. These processes would take days to run (on the full 96 samples) and then the processes would become “stuck” (viewed via the top command in OS X).

Read More

SRA Submission – Genome sequencing of the Olympia oyster (Ostrea lurida)

  • ~1 min read

Adding our Olympia oyster genome sequencing (sequencing done by BGI) to the NCBI Sequence Read Archive (SRS). The current status can be seen in the screen cap below. Release date is set for a year from now, but will likely bump it up. Need Steven to review the details of the submission (BioProject, Experiment descriptions, etc.) before I initiate the public release. Will update this post with the SRA number once we receive it.

Read More

SRA Submission – Genome sequencing of the Pacific geoduck (Panopea generosa)

  • ~1 min read

Adding our geoduck genome sequencing (sequencing done by BGI) to the NCBI Sequence Read Archive (SRS). The current status can be seen in the screen cap below. Release date is set for a year from now, but will likely bump it up. Need Steven to review the details of the submission (BioProject, Experiment descriptions, etc.) before I initiate the public release. Will update this post with the SRA number once we receive it.

Read More

Data Management - O.lurida 2bRAD Dec2015 Undetermined FASTQ files

  • ~1 min read

An astute observation by Katherine Silliman revealed that the FASTQ files I had moved to our high-throughput sequencing archive on our server Owl, only had two FASTQ files labeled as “undetermined”. Based on the number of lanes we had sequenced, we should have had many more. Turns out that the undetermined FASTQ files that were present in different sub-folders of the Genewiz project data were not uniquely named. Thus, when I moved them over (via a bash script), the undetermined files were continually overwritten, until we were left with only two FASTQ files labeled as undetermined.

Read More

Back to Top ↑

2015

Data Storage - Synology DX513

  • ~1 min read

Running a bit low on storage on Owl (Synology DS1812+) and we will be receiving a ton of data in the next few months, so we purchased a Synology DX513. It’s an expansion unit designed specifically for seamlessly expanding our existing storage volume on Owl.

Read More

DNA Isolation - Geoduck Ctenidia gDNA

  • 1 min read

Isolated additional gDNA for the genome sequencing. In an attempt to obtain better yields, I used ctenidia (instead of adductor muscle). Additionally, to try to improve the quality (260/280 & 260/230 ratios) of the gDNA, I added a chloroform step after the initial tissue homogenization.

Read More

Restriction Digest – Oly gDNA for RAD-seq w/AlfI

  • 1 min read

Previously initiated the RAD-seq procedure for the sample set described below. However, the test scale PCR yielded poor results. Katherine Silliman suggested that the poor performance of the test scale PCR was likely due to low numbers of adaptor-ligated fragments. Since the input DNA is so degraded, I’ve repeated this using 9μg of input DNA (instead of the recommended 1.2μg). This should increase the number of available cleavage sites for AlfI, thus improving the number of available ligation sites for the adaptors.

Read More

Uninterruptible Power Supplies (UPS)

  • 1 min read

A new UPS we installed this week for our qPCR machine (Opticon2 - BioRad) to handle power surges and power outages doesn’t seem to be working properly. With the qPCR machine (and computer and NanoDrop1000) plugged into the “battery” outlets on the UPS, this is what happens when the Opticon goes through a heating cycle:

Read More

Server Email Notifications Fix - Eagle

  • ~1 min read

The system was previously set to use Steven’s Comcast SMTP server. Sending a test email from Eagle failed, indicating authentication failure. I changed this to use the University of Washington’s email server for outgoing messages. Here’s how…

Read More

SsoFast EvaGreen Supermix Aliquots

  • ~1 min read

Prepared sterile, ~1.5mL aliquots of SsoFast EvaGreen Supermix (received 20150810) in 2.0mL screw cap tubes. All aliquots were dated and stored @ -20C in the “PCR Supplies” box.

Read More

Reverse Transcription – O.lurida DNased RNA 1hr post-mechanical stress

  • ~1 min read

Performed reverse transcription on the Olympia oyster DNased RNA from the 1hr post-mechanical stress samples from Jake’s project. To accommodate the large numbers of anticipated genes to be targeted in subsequent qPCRs, I prepared 100μL reactions (normally, 25μL reactions are prepared) using 250ng of each DNased RNA. A 1:10 dilution of the oligo dT primers (Promega) was prepared to improve pipetting accuracy. All incubations were performed in a thermal cycler without using a heated lid.

Read More

Server HDD Failure - Owl

  • 1 min read

We had our first true test of the Synology RAID redundancy with our Synology 1812+ server (Owl). One of the hard drives (HDD) failed. All of the other drives were fine, the data was intact and we had a new replacement HDD on hand. However, there was one shortcoming: no email notification of the drive failure. Luckily, the Synology server is next to Steven’s office and he could hear an audible beeping alerting him to the fact that something was wrong. In any case, the email notifications have been fixed and a replacement hard drive was added to the system. Here’s how these things were accomplished.

Read More

SsoFast EvaGreen Supermix Aliquots

  • ~1 min read

Prepared sterile, 1.0mL aliquots of SsoFast EvaGreen Supermix (received today) in 2.0mL screw cap tubes. All aliquots were dated and stored @ -20C in the “PCR Supplies” box.

Read More

Opticon2 Calibration

  • 2 min read

Jake and Steven recently noticed localized “hot spots” on most of Jake’s recent qPCRs, where higher levels of fluorescence were consistently showing up in interior portions of the plates than the outer portion of the plates.

Read More

Reverse Transcription - O.lurida DNased RNA Controls and 1hr Heat Shock

  • ~1 min read

Performed reverse transcription on the Olympia oyster DNased RNA from the control samples and the 1hr heat shock samples of Jake’s project. To accommodate the large numbers of anticipated genes to be targeted in subsequent qPCRs, I prepared 100μL reactions (normally, 25μL reactions are prepared) using 250ng of each DNased RNA. A 1:10 dilution of the oligo dT primers (Promega) was prepared to improve pipetting accuracy. All incubations were performed in a thermal cycler without using a heated lid.

Read More

Gel Purification - Olympia Oyster and Sea Pen PCRs

  • ~1 min read

Purified DNA from the remaining PCR bands excised by Jake on 20150609 and 20150610, as well as Jonathan’s sea pen PCRs from 20150604, using Ultrafree-DA spin columns (Millipore). Transferred gel pieces from storage tubes (1.5mL snap cap tubes) to spin columns. Spun 10,000g, 5mins @ RT. Transferred purified DNA back to original storage tubes. See the sequence_log (Google Sheet) for a full list of the samples and the sequencing plates layouts. Purified DNA was stored @ 4C O/N. Will prepare and submit plates for Sanger sequencing tomorrow.

Read More

ISO Creation - OpticonMonitor3 Disc Cloning

  • ~1 min read

Since many newer computers are coming without optical disc drives (including my laptop, which I want to install this software on), I created an .iso disc image of the OpticonMonitor3 (BioRad) installation disc.

Read More

Sequence Data Analysis - C.gigas Larvae OA BS-Seq Data

  • 1 min read

Compared total amount of data generated from each index. The commands below send the output of the ‘ls -l’ command to awk. Awk sums the file sizes, found in the 5th field ($5) of the ‘ls -l’ command, then prints the sum, divided by 1024^3 to convert from bytes to gigabytes.

Read More

Sequence Data - C.gigas OA Larvae BS-Seq Demultiplexed

  • 1 min read

I had previously contacted Doug Turnbull at the Univ. of Oregon Genomics Core Facility for help demultiplexing this data, as it was initially returned to us as a single data set with “no index” (i.e. barcode) set for any of the libraries that were sequenced. As it turns out, when multiplexed libraries are sequenced using the Illumina platform, an index read step needs to be “enabled” on the machine for sequencing. Otherwise, the machine does not perform the index read step (since it wouldn’t be necessary for a single library). Surprisingly, the sample submission form for the Univ. of Oregon Genomics Core Facility  doesn’t request any information regarding whether or not a submitted sample has been multiplexed. However, by default, they enable the index read step on all sequencing runs. I provided them with the barcodes and they demultiplexed them after the fact.

Read More

Sequence Data - LSU C.virginica Oil Spill MBD BS-Seq Demultiplexed

  • 1 min read

I had previously contacted Doug Turnbull at the Univ. of Oregon Genomics Core Facility for help demultiplexing this data, as it was initially returned to us as a single data set with “no index” (i.e. barcode) set for any of the libraries that were sequenced. As it turns out, when multiplexed libraries are sequenced using the Illumina platform, an index read step needs to be “enabled” on the machine for sequencing. Otherwise, the machine does not perform the index read step (since it wouldn’t be necessary for a single library). Surprisingly, the sample submission form for the Univ. of Oregon Genomics Core Facility  doesn’t request any information regarding whether or not a submitted sample has been multiplexed. However, by default, they enable the index read step on all sequencing runs. I provided them with the barcodes and they demultiplexed them after the fact.

Read More

Epinext Adaptor 1 Counts - LSU C.virginica Oil Spill Samples

  • ~1 min read

Before contacting the Univ. of Oregon facility for help with this sequence demultiplexing dilemma, I contacted Epigentek to find out what the other adaptor sequence that is used in the EpiNext Post-Bisulfite DNA Library Preparation Kit (Illumina). I used grep and fastx_barcode_splitter to determine how many reads (if any) contained this adaptor sequence. All analysis was performed in the embedded Jupyter (IPython) notebook embedded below.

Read More

DNA Quantification - C.gigas Larvae 1000ppm

  • ~1 min read

After the discovery that there wasn’t any DNA in the BS-seq Illumina library prep and no DNA in the bisulfite-treated DNA pool, I decided to try to recover any residual DNA left in the 1B2 sample. Sample 1B2 (sheared on 20150109) was dry, so I added 20μL of Buffer EB (Qiagen) to the tube. I vortexed both the 1B1 and 1B2 samples and quantified on the NanoDrop1000 (ThermoFisher). I also re-quantified the pooled BS-treated sample that had been used as input DNA for the libraries.

Read More

DNA Quantification - Claire’s Sheared C.gigas Mantle Heat Shock Samples

  • ~1 min read

I previously checked Claire’s sheared DNA on the Bioanalyzer to verify the fragment size and to quantify the samples. Looking at her notebook, her numbers differ greatly from the Bioanalyzer, possibly due to the fact that the DNA1000 assay chip used only measures DNA fragments up to 1000bp in size. If her shearing was incomplete, then there would be DNA fragments larger than 1000bp that wouldn’t have been measured by the Bioanalyzer. So, I decided to quantify the samples on the NanoDrop1000 (ThermoFisher) again.

Read More

Library Prep - Quantification of C.gigas larvae OA 1000ppm library

  • ~1 min read

The completed BS Illumina library made on Friday (1000ppm) was quantified via fluorescence using the Quant-iT DNA BR Kit (Life Technologies/Invitrogen).  Also quantified Jake’s libraries. Used 1μL of  each sample and the standards.  All standards were run in duplicate.  Due to limited sample, the libraries were only processed singularly, without replication.  Fluorescence was measured on a FLx800 plate reader (BioTek), using the Gen5 (BioTek) software for all calculations.

Read More

Bisuflite NGS Library Prep – C.gigas larvae OA bisulfite library quantification

  • ~1 min read

The two completed BS Illumina libraries (400ppm and 1000ppm) were quantified via fluorescence using the Quant-iT DNA BR Kit (Life Technologies/Invitrogen).  Used 1uL of  each sample and the standards.  All standards were run in triplicate.  Due to limited sample, the two libraries were only processed singularly, without replication.  Fluorescence was measured on a FLx800 plate reader (BioTek).

Read More

Bisuflite NGS Library Prep - C.gigas larvae OA bisulfite DNA

  • ~1 min read

The two pooled bisulfite-treated DNA samples (400ppm and 1000ppm) from 20150114 were used to prepare bisulfite Illumina libraries with [EpiNext Post-Bisulfite DNA Library Preparation Kit (Illumina) (Epigentek)(https://github.com/sr320/LabDocs/blob/master/protocols/Commercial_Protocols/Epigentek_PostBisulfiteIlluminaLibraryPrep_P-1055.pdf).  Changes to the manufacturer’s protocol:

Read More

Library Cleanup - LSU C.virginica MBD BS Library

  • 1 min read

I was contacted by the sequencing facility at the University of Oregon regarding a sample quality issue with our library.  As evidenced by the electropherogram below, there is a great deal of adaptor primer dimer (the peak at 128bp):

Read More

SpeedVac - C.gigas larvae OA DNA

  • ~1 min read

The DNA extracted and sheared on 20150109 was in a volume too great to proceed with bisulfite conversion.  Dried the samples to complete dryness in a SpeedVac (~4hrs).  Reconsitituted DNA in 24μL of NanoPure water.  Will bisulfite convert tomorrow.

Read More

Back to Top ↑

2014

DNA Shearing - LSU C.virginica Oil Spill gDNA

  • ~1 min read

Used the remainder of the “sheared” samples (see today’s earlier entry; ~2750ng). Brought the volumes up to 80uL and transferred to 0.5mL snap cap tubes. The volume of 80uL was selected because it’s above the minimum volume required for shearing in 0.5mL tubes (10uL according to the Biorupter 300 manual) and the MethylMiner Kit (Invitrogen) requires the input DNA volume to be <= 80uL.

Read More

Gel - Sheared gDNA

  • ~1 min read

Ran ~250ng (out of 3000ng, according to Claire) of LSU C.virginica oil spill gDNA on a gel that was previously sheared by Claire to verify that shearing was successful.

Read More

RNA-Seq - Sea Star Data Download

  • 1 min read

Received RNA-seq data from Cornell. They provided a convenient download script for retrieving all the data files at one time (a bash script containing a series of wget commands with each individual file’s URL), which is faster/easier than performing individual wget commands for each individual file and faster/easier then using the Synology “Download Station” app when so many URLs are involved.

Read More

DNA Isolation - Claire’s C.gigas Female Gonad

  • 2 min read

Trying this sample again(!!), but will now use TE for pellet resuspension to prevent sample degradation. Incubated sample RT on rotator in 500uL of DNazol + 2.7uL of Proteinase K (Fermentas; Stock 18.5mg/mL) for 5hrs. Added additional 500uL of DNazol, mixed gently and followed DNazol manufacturer’s protocol. Performed first pellet was with 70% DNazol/ 30% EtOH solution. Resuspended pellet in 200uL of TE and spec’d on NanoDrop1000.

Read More

DNA Isolation - Test Sample

  • 1 min read

Due to the recent poor quality gDNA that has been isolated from C.gigas gonad, I decided to do a quick test using TE for DNA pellet resuspension in hopes that old Buffer EB (Qiagen) or old nuclease-free H2O (Promega) are to blame for the apparent, rapid degradation that I’ve experienced.

Read More

DNA Quality Check - Yanouk’s Oyster gDNA

  • ~1 min read

We’ve had some Illumina sequencing issues with Yanouk’s samples, so I ran the samples out on a 0.8% agarose gel to evaluate the levels of degradation. Loaded 2uL of each sample. Did not load equal quantities of gDNA, due to the lack of available gDNA in the samples we submitted for Illumina sequencing. Added 2uL of H2O to samples 37 & 38 in hopes of having sufficient DNA for visualization on the gel.

Read More

DNA Isolation - Geoduck

  • ~1 min read

Isolated additional geoduck gDNA from the two fresh (now frozen) geoduck’s that Brent provided me with on 20140212 so that we can potentially isolate RNA from the same geoducks to tie in with the DNA Illumina sequencing that Axa will be conducting. Isolated DNA using the DNeasy Blood & Tissue Kit (Qiagen) according to the manufacturer’s protocol (incubated minced siphon tissue at 56C for 3hrs). Eluted with 75uL of ddH2O and spec’d on NanoDrop1000.

Read More

DNA Precipitation - Geoduck DNA from 20140213

  • ~1 min read

After speaking with Axa regarding the DNA concentrations, he would like the DNA from the ethanol-fixed tissue to be more concentrated, and he wants them in ddH2O instead of Buffer AE (from the Qiagen DNeasy Kit). So, I preformed a standard ethanol precipitation. Added 0.1 volumes of 3M sodium acetate (pH = 5.2) [15uL], 2.5 volumes of 100% ethanol [412.5uL] and incubated @ -20C over the weekend.

Read More

DNA Isolation - Geoduck

  • ~1 min read

Since yesterday’s DNA isolation failed to yield sufficient quantity of DNA from the ethanol-fixed samples, I isolated additional DNA from the same samples.

Read More

DNA Isolation - Geoduck

  • ~1 min read

Isolated gDNA from 6 geoduck siphon samples provided by Brent using the Qiagen DNeasy Spin Kit. Samples were as follows:

Read More

Back to Top ↑

2013

Gylcogen and Carboyhydrate Assays - Emma’s C.gigas Whole Body Samples

  • ~1 min read

Samples were previously freeze dried overnight and stored @ -20C. To maximize sample homogeneity and, thus, increase accuracy of both assays, all samples were mechanically pulverized in their existing tubes. Approximately half of each sample was weighed and used for the glycogen assay. The remainder of each sample was stored @ -20C.

Read More

PCR - Lake Trout C1q

  • ~1 min read

Repeated PCR from 20130919, but with a newly designed reverse primer. Primers were designed using MethPrimer (SR IDs: 1553, 1555). Primers were designed using MethPrimer:

Read More

PCR - Lake Trout C1q

  • ~1 min read

Repeated PCR from 20130919, but with a newly designed set of primers that targets the desired region of C1q for sequencing (SR IDs: 1553, 1554). Primers were designed in Geneious.

Read More

PCR - Lake Trout C1q

  • ~1 min read

Ran PCR on lake trout DNA and lake trout bisulfite-converted DNA. Used primers SRIDs: 1551 and 1552. DNA was isolated by Caroline Storer on 4/4/2011 and bisulfite converted on 4/7/2011. Master mix and cycling params are here:

Read More

PCR - Hexokinase Partial CDS

  • ~1 min read

Performed PCR using the primers CG_HK_CDS_2132-2158 (SRID: 1521) and Cg_Hk_CDS_3’_no_stop (SRID: 1519) on pooled C.gigas cDNA (from DATE).

Read More

PCR - Hexokinase Promoter and CDS

  • ~1 min read

Performed PCR to amplify the C.gigas hexokinase (ACCESSION#) promoter region (-2059bp) and the CDS without the stop codon. Elimination of the stop codon allows for subsequent cloning into the pBAD-TOPO expression vector, which will incorporate the V5 epitope tag sequence. This tag will be used to distinguish between endogenous hexokinase expression and expression generated from our hexokinase construct.

Read More

Reverse Transcription - Herring RNA from 20091026

  • ~1 min read

Performed an RT reaction on pooled herring gonad and liver mRNA from 20091026 for James Raymond at the UNLV. A single RT reaction was performed using 12.75uL (208ng) of the pooled gonad mRNA and 5uL (132.5ng) of the pooled liver RNA, according to our default MMLV (Promega) protocol. After reaction was completed, sample was stored @ -20C and then shipped to James Raymond on 20130214.

Read More

Back to Top ↑

2012

Reverse Transcription - FISH441 RNA

  • ~1 min read

Reverse transcribed the class FISH441 RNA to cDNA. Followed protocol provided on the FISH441 Wiki page, NOT the usual Roberts Lab protocol, with some modifications.

Read More

Minipreps - Emma’s Illumina Library Cloning

  • ~1 min read

Performed plasmid isolation on 17 bacterial cultures Emma inoculated yesterday using the QIAprep Spin Mini Kit (Qiagen) using ~1.4mL of culture according to the manufacturer’s protocol. Plasmid DNA was eluted with 50uL of Buffer EB. Tubes were stored @ 4C in the refrigerator in FTR 213.

Read More

Oligo Reconstitution - Illumina RNAseq Library Oligos and Barcodes

  • ~1 min read

Reconstituted all of the oligos and barcodes for library construction in TE (pH = 8.0) to a final concentration of 100uM. Created 10uM working stocks of all oligos and barcodes. All samples (stocks and working stocks) are stored @ -80C in their own box (Illumina Library Oligos & Barcodes) due to the fact that one of the oligos is an RNA oligo and requires storage at -80C.

Read More

Chloroform Clean Up - Lexie’s QPX RNA from 20110504

  • 1 min read

After submission of QPX samples to HTGU for Illumina library prep yesterday, I was notified that there was insufficient RNA for the QPX RNA samples. I checked the source RNA on the Roberts Lab NanoDrop1000 and determined that they had high phenol contamination (large peak at 270nm), which results in a large exaggeration in the OD260 absorbance (NanoDrop1000 report[JPEG]; notice terrible OD260/280 ratios; did not save screen shot of absorbance peaks.). As such, the concentrations that Lexie had listed in her notebook for these samples are highly inaccurate and highly inflated. To remove the phenol, I brought all of her QPX RNA samples from 20110504 up to ~200uL with 0.1%DEPC-H2O, added 200uL of chloroform, vortexed for 30s, spun at 12,500g RT for 15mins, and transferred aqueous phase to new tube. Then performed an ethanol precipitation on the aqueous phase. Added 0.1 vols of 3.0M sodium acetate (pH = 5.2), 2.5 vols of 100% EtOH, mixed and incubated at -20C for 1hr. Pelleted RNA by spinning at 16,000g 4C for 15mins.

Read More

Reverse Transcription - DNased C.gigas Larval RNA from 20120427

  • ~1 min read

Performed reverse transcription using random primers (Promega) diluted 1:100 (5ng/uL) with 175ng of DNased total RNA. Random primers were used because we will be targeting V.tubiashii RNA instead of eukaryotic RNA. Reverse transcription was performed with M-MLV Reverse Transcriptase (Promega) according to the manufacturer’s protocol. Calcs are here.

Read More

qPCR - Check DNased RNA from Earlier Today for Residual gDNA

  • ~1 min read

Ran qPCR using V.tubiashii VtpA primers (from Elene; no SR ID). Used 0.5uL of each DNased RNA sample, which equals ~40ng of RNA, which would be the equivalent amount of RNA that would end up in a qPCR rxn after cDNA has been made (using 1uL of cDNA). Used the filter DNA extraction from samples #279 from DATE as a positive control. Master mix calcs are here. Plate layout, cycling params, etc. can be found in the qPCR Report (see Results).

Read More

gDNA Isolation - C.gigas Larvae from Taylor Summer 2011

  • ~1 min read

Samples that had been split from earlier today (see the RNA Isolation below) were resuspended in 1mL of DNAzol (MRC). 100ug of Proteinase K (Fermentas) was added to each sample. Samples were incubated at RT, O/N on a rotator. On 20120427 samples were pelleted 10mins, 10,000g, and supe transferred to fresh tube. DNA was precipitated with 0.5mL of 100% EtOH, mixed gently and pelleted 5mins, 5000g. Supe was discarded, pellets were washed with 1mL 75% EtOH, re-pelleted at same speed as previous step, supe discarded and pellets were resuspended in NanoPure H2O. Samples were spec’d on the Roberts Lab NanoDrop1000.

Read More

RNA Isolation - C.gigas Larvae from Taylor Summer 2011

  • ~1 min read

Samples had been stored in RNA Later (Ambion). Samples were pelleted and the RNA Later supe removed. Samples were washed (2x) with 1mL TE (pH = 8.0) to remove excess salt resulting from the RNA Later. Samples were split, roughly equally, into two separate tubes. Samples were pelleted and the supe removed. One tube from each sample was set aside for gDNA isolation using DNAzol (MRC). The other tube was vortexed vigorously in TriReagent (MRC) and the then treated according to protocol. Samples were resuspended in 100uL of 0.1% DEPC-H2O and spec’d on the Roberts Lab NanoDrop 1000.

Read More

qPCR - Taylor Water Filter DNA Extracts from 20120322

  • 1 min read

Ran qPCR on the Taylor water filter DNA extracts from 20120322 using V.tubiashii VtpA primers (provide by Elene; no SR ID?) instead of 16s primers, which failed to produce acceptable results in the melt curves (see 20120323). Additionally, Elene has a standard curve for V. tubiashii (from 1/12/2011) based off of CFUs/mL, which will allow us to quantify theoretical number of V.tubiashii CFUs present in each sample.

Read More

qPCR - Dave’s Manila Calm (Venerupis philippinarum) DNased RNA from yesterday and 20120302

  • 1 min read

Performed qPCR on all DNased RNA samples from this group (samples #1-48) using beta actin primers (SR IDs: 1379, 1380). 0.5uL of each DNased RNA was used, which was the equivalent of ~40ng, in order to simulate the amount of RNA present in the subsequent cDNA (1000ng of RNA in 25uL cDNA; use 1uL of cDNA in qPCR reaction). Master mix calcs are here. Plate layout, cycling params, etc., can be found in the qPCR Report (see Results). 0.5uL of total RNA from sample Vp gill 01 was used to serve as a positive control, since Dave has no existing V. phillippinarum cDNA.

Read More

qPCR - cDNA from 20120208

  • ~1 min read

Performed qPCR on all 12 samples. Used the following primers, provided by Elene, to detect V.tubiashii expression:

Read More

qPCR - cDNA from earlier today

  • 1 min read

Performed qPCR on all 12 samples. Used Cg_EF1aF/R2 (SR IDs: 1410 & 1412) for one set of qPCRs and Vtub_16s_F/R (SR IDs: 455 & 456) for the other set of qPCRs. Used pooled C.gigas cDNA (from 20110311) and RE22 DNA (provided by Elene) as positive controls for C.gigas and V.tubiashii, respectively. C.gigas gDNA (7ng of BB16 from 20110201) was used as a negative control for EF1a. Master mix calcs are here. Plate layout, cycling params, etc can be found in the qPCR Report (see Results). All samples were run in duplicate.

Read More

qPCR - DNased RNA from earlier today

  • ~1 min read

Checked DNased RNA samples from earlier today for the presence of residual gDNA. Used C.gigas BB16 gDNA (from 20110201) diluted to ~7ng/uL as a positive control to match the dilution factor of the RNA that will be used in the reverse transcription reaction (175ng in 25uL = 7ng/uL). All samples were run in duplicate. Master mix calcs are here. Plate layout, cycling params, etc can be found in the qPCR Report (see Results).

Read More

RNA Isolation - C.gigas Larvae from 20110412 & 20110705 (Continued from 20120112)

  • ~1 min read

All of the RNA samples were re-combined with their respective counterparts and subject to a standard EtOH precipitation (0.1 volumes of 3M NaOAc, pH = 5.2, 2.5 volumes 100% EtOH; incubated -80C 1hr; pelleted; washed with 1mL 70% EtOH; pelleted). Pellets were washed two additional times (for a total of three washes) with 70% EtOH. RNA was resuspended in 50uL of 0.1% DEPC-H2O and spec’d on the Roberts Lab NanoDrop 1000.

Read More

RNA Isolation - C.gigas Larvae from 20110412 & 20110705

  • 2 min read

RNA was isolated from C.gigas larvae collected from Taylor Shellfish hatchery on the dates noted above. Samples were in RNA Later. RNA Later was removed. Attempted homogenization with a pestle proved futile, as a significant quantity of larvae were sticking to the pestle and were nearly impossible to wash off using TriReagent as a rinsing agent. Due to this, all samples were vortexed for 1min in 1mL of TriReagent. It should be noted that the TriReagent took on a cloudy appearance and even showed some separation into two layers upon letting the samples sit. This was not normal and I was immediately concerned about the high salt content from residual RNA Later. Samples were treated normally with the following changes:

Read More

Back to Top ↑

2011

Mini-preps - COX/PGS Cloning Colonies from today

  • ~1 min read

Selected 10 colonies (1-8, 18, 28) for mini-preps. Inoculated 5mL 1x LB + 50ug/mL of Kanamycin. Incubated O/N, 37C, 200RPM. 3mL of each culture were used for mini-preps. Used Qiagen kit. Samples were eluted w/30uL of EB.

Read More

PCR - COX/PGS Cloning Colony Screens from yesterday

  • 1 min read

Performed PCR on 40 colonies using both qPCR primer sets to see if I could differentiate between which colonies potentially contained each isoform to reduce the amount of clones needed for sequencing. Master mix and cycling params are here. Primers used were:

Read More

Cloning - Purified COX/PGS “qPCR Fragment” from 20111006

  • ~1 min read

Cloned the purified “qPCR Fragment” from 20111006 using the TOPO TA Cloning Kit (Invitrogen). Performed a half reaction (total volume = 3uL), using 1uL of purified PCR product. Incubated at RT for 20mins and then placed reaction on ice. Transformed chemically competent TOP 10 cells (Invitrogen) and heat shocked at 42C for 30s. Added 250uL of RT S.O.C. medium and incubated at 37C, 200RPM. Plated cells on pre-warmed Kan50+X-Gal plates (plates from 20110726; X-Gal added ~30mins before plating cells). Incubated plates O/N, 37C.

Read More

Ethanol Precipitation - Full-length PGS1 cDNA (from 20110921)

  • ~1 min read

Performed an EtOH on gel-purified PCR products from 20110921. Briefly, added 0.1 vols of 3M sodium acetate (pH=5.2; 43uL), mixed and then added 2.5 vols of 100% EtOH (1182.5uL). Mixed, split into two tubes (due to high volume not fitting in a single tube) and incubated @ -80C O/N. Pelleted DNA 16,000g, 20mins, 4C. Discarded supe. Washed pellet w/ 1mL 70% EtOH. Pelleted DNA 16,000g, 15mins, 4C. Discarded supe. Resuspended both pellets in a TOTAL of 25uL Qiagen Buffer EB (10mM Tris-HCl) and spec’d.

Read More

PCR - Full-length PGS1 cDNA

  • ~1 min read

Still have insufficient quantities of DNA for sequencing. Master mix calcs and cycling params are here. Additionally, used some of the purified PCR product as template in one of the reactions, just for comparison purposes. cDNA template was pooled cDNA from 20110311 from various C.gigas tissues. Also, increased the amount of template 4-fold in an attempt to obtain higher yields of PCR products for sequencing.

Read More

Ethanol Precipitation - Purified PGS1 PCR from yesterday

  • ~1 min read

Added 0.1 vols of 3M sodium acetate (pH = 5.2; 38uL) and 2 vols of 100% EtOH (836uL). Incubated 30mins @ -20C. Pelleted DNA 16,000g, 15mins, 4C. Removed supe. Washed pellet w/1mL 70% EtOH. Pelleted DNA 16,000g, 15mins, 4C. Removed supe. Air-dried pellet. Resuspended in 50uL of Qiagen EB Buffer and spec’d.

Read More

PCR - Full-length PGS2 cDNA

  • ~1 min read

Repeated PCR from 20110825 to attempt to amplify the full-length cDNA for PGS2 (COX2), however this time using a more robust polymerase (Amplitaq Gold) in hopes of getting results. Additionally, tried 3 different Mg2+ concentrations (1.5mM, 2.0mM, and 3.0mM). Master mix calcs and cycling params are here. cDNA was pooled cDNA made 20110311 from various tissues. PGS2 primers = 1376, 1375.

Read More

Sequencing - C.gigas COX2/PGS2 Clone #4 from 20110728

  • ~1 min read

Used new primers for sequencing (SR IDs: 1351 & 1352) clone #4. Sequenced clone two times in each direction. DNA and primers were sent for sequencing at ASU. Requested “High GC” treatment to help overcome the issue seen on 20110728.

Read More

Cloning - C.gigas COX2/PGS2 5’/3’ RACE Products (from earlier today)

  • ~1 min read

The bands that were excised and purified earlier today were cloned in to pCR2.1 using the TOPO TA Cloning Kit (Invitrogen) according to the manufacturer’s protocol with the following changes: used 4uL of all PCR products, incubated ligation reactions for 15mins @ RT, incubated competent cells with ligation reactions for 15mins on ice.

Read More

5’/3’ RACE - C.gigas COX2/PGS2 Nested RACE PCR

  • 1 min read

Performed nested RACE PCR on the RACE PCR products generated on 20110722 using the following nested primers: PGS2_ngspRACE_5’ (SR ID: 1350) and PGS2_ngspRACE_3’ (SR ID: 1349). Removed 2uL from each of the primary PCR reactions and brought up to 100uL in tricine EDTA (supplied in the Clontech SMARTer RACE cDNA Amplification Kit). Performed the nested RACE PCR according to the Clontech manual. Briefly, this is the same as the primary RACE PCR reaction, but using 5uL of the diluted primary PCR product and 1uL of the Nested Universal Primer (instead of 5uL of the 10X Universal Primer Mix). Master mix calcs and set up are here. Cycling params followed “Program 2” of the Clontech protocol, modified for nested primers, and are as follows:

Read More

Clone Restreaking - PGS2 Hi/Lo Clones (from 20110421)

  • ~1 min read

Sequencing of the PGS2/COX2 clone failed (was empty vector). Restreaked bacterial clones on to a Kan50 plate (made 20110413 by SJW) from a plate that Caroline Storer had created from cloning colony selection on 20110421. Samples were labeled as PGS Lo 1 & 2 and PGS Hi 3 & 4. Additionally, there were red numbers on the plate associated with these four samples. They were 42 - 45, respectively. PGS Hi 4 (#45) was previously grown up and sequenced. This sample is what produced vector only sequence. Incubated O/N @ 37C. Hopefully we’ll bacteria is still viable and will have samples to grow up for miniprep, plamsid iso and sequencing.

Read More

qPCR - C.gigas actin and GAPDH on V.vulnificus exposure cDNA (from 20110311)

  • ~1 min read

Ran a qPCR on all cDNA samples from the V.vulnificus exposure experiment from 20110111. This qPCR was to test 2 of 4 potential normalizing genes to evaluate which genes show the least amount of effect from the treatments in this experiment. Primers for actin used were Cg_Actin_306_F (SR ID: 1170), Cg_Actin_408_R (SR ID: 1171). Samples were run in duplicate. Master mix calcs are here. The master mix info is the same that was used earlier today, but with the primers noted above, not those listed on the calcs page. Plate layout, cycling params, etc., can be seen in the qPCR Report (see Results).

Read More

qPCR - C.gigas 18s and EF1a on V.vulnificus exposure cDNA (from 20110311)

  • ~1 min read

Ran a qPCR on all cDNA samples from the V.vulnificus exposure experiment from 20110111. This qPCR was to test 2 of 4 potential normalizing genes to evaluate which genes show the least amount of effect from the treatments in this experiment. Primers for 18s used were Cg_18s_1644_F (SR ID: 1168), Cg_18s_1750_R (SR ID: 1169). Primers for EF1a used were EF1_qPCR_5’ (SR ID: 309), EF1_qPCR_3’ (SR ID: 310)Samples were run in duplicate. Master mix calcs are here. The master mix info is the same that was used earlier today, but with the primers noted above, not those listed on the calcs page. Plate layout, cycling params, etc., can be seen in the qPCR Report (see Results).

Read More

qPCR - C.gigas COX2 on V.vulnificus exposure cDNA (from 20110311)

  • ~1 min read

Ran a qPCR on all cDNA samples from the V.vulnificus exposure experiment from 20110111. Primers used were Cg_COX1/2_qPCR_F (SR ID: 1192) & Cg_COX2_454align1_R (SR ID: 1190). Samples were run in duplicate. Master mix calcs are here. The master mix info is the same that was used earlier today, but with the primers noted above, not those listed on the calcs page. Plate layout, cycling params, etc., can be seen in the qPCR Report (see Results).

Read More

qPCR - Hard Clam NGS Primer Checks

  • ~1 min read

Ran a qPCR to evaluate a large batch of primers (40 sets) that were ordered per Steven, based off of the most recent SOLiD run (samples submitted 3/10/2011; see Dave’s notebook for more info). Pooled cDNA (2uL from each individual; from 20110511) was used. Master mix calcs are here. Plate layout, cycling params, etc. can be found in the qPCR Report (see Results). The list of primers tested is available in the Primer Database and consist of SR IDs 1233 - 1312. For brevity, samples were only labelled with the corresponding contig number.

Read More

qPCR - Emma’s New 3KDSqPCR Primers

  • 2 min read

Due to previous contamination issues with Emma’s primers, Emma asked me to order new primers, reconstitute them and run a qPCR for her to see if we could eliminate her contamination issues with this primer set. cDNA template was supplied by Emma (from 2/2/11) and was from a C.gigas 3hr Vibrio vulnificus challenge. Samples were run in duplicate, as requested. Master mix calcs are here. Plate layout, cycling params, etc. can be found in the qPCR Report (see Results). Primer set used was:

Read More

DNase - Hard Clam Gill RNA (from earlier today)

  • ~1 min read

DNased 5ug of RNA from each sample with Ambion’s Turbo DNA-free Kit, according to the manufacturer’s rigorous protocol. Samples were spec’d and stored @ -80C in the “Hard Clam V.t. Experiment RNA” box.

Read More

Ligations - COX1/COX2 PCR Products

  • ~1 min read

Performed ligations/cloning on a variety of COX1 genomic and COX 5’ RACE products using the TOPO TA Cloning Kit (Invitrogen). Used 2uL of gel-purified PCR product in each cloning rxn, 2.5uL of H2O, 1uL of salt solution, and 0.5uL of the Invitrogen pCR2.1 vector. Incubated samples for 5mins at RT. Used 2uL of the cloning reaction to transform TOP10 chemically competent cells (Invitrogen), mixed very gently, incubated on ice for 5mins, heat shocked at 42C for 30s and immediately placed on ice. Added 250uL of SOC Medium and incubated tubes at 37C, 200RPM for 1hr. Plated 50uL of each transformation on LB+Kan plates (made by Steven on unknown date with unknown Kan concentration) containing 40uL of 40mg/mL X-gal. Incubated O/N at 37C. Remaining volume of transformed bacteria were stored @ 4C.

Read More

5’/3’ RACE PCRs - Nested PCRs for COX2 Sequence

  • 1 min read

Due to the failure of the primary PCR on both 5’ and 3’ RACE cDNA libraries (from 20080619) yesterday, will perform nested PCR using a nested GSP designed by Steven (CgPGSRACEsrNGSP1; SR ID:1209). The 5uL of PCR reactions that were set aside yesterday were diluted to 250uL with tricine-EDTA (supplied with the Clontech SMARTer RACE cDNA Amplification Kit) as instructed in the Clontech manual. The master mix and tube layouts were exactly the same as yesterday’s, but instead of using 2.5uL of RACE cDNA library as template, I used 5uL of the diluted PCR reaction. Additionally, Universal Nested Primers were used instead of the Universal Primer Mix (both supplied in the kit). Cycling parameters followed “Program 2” from the Clontech manual for 25 cycles.

Read More

5’/3’ RACE PCRs - COX2 Sequence on 5’ & 3’ RACE Libraries (from 20080619)

  • ~1 min read

Ran PCRs on both the 5’ & 3’ RACE libraries created 20080619 with a new COX2 gene-specifc (GSP) primer designed by Steven (CgPGSRACEsrGSP1; SR ID: 1208). Although this primer was designed to obtain additional 5’ sequence, it was used with both 5’ and 3’ libraries as a precaution in case it accidentally designed on the wrong strand. PCR rxn was set up according to the Clontech SMARTer RACE cDNA Amplification Kit. Master mix calcs are here. PCR cycling followed “Program 1” from the Clontech manual for 25 cycles.

Read More

mRNA Isolation - Pooled Black Abalone Dg RNA (from Abalone Dg Exp 1)

  • ~1 min read

mRNA was isolated for SOLiD sequencing by HTGU. Made two pools of San Nick RNA (Control and Exposed) using equal amounts (5ug) of each individual sample. Individual samples used can be found here. mRNA was isolated using Ambion’s Micro PolyAPurist Kit according to protocol. Procedure was performed two times on each pool and then EtOH precipitated. Samples were resuspended in 10uL of The RNA Storage Solution provided in the kit and spec’d on the Roberts Lab ND1000. Samples were stored @ -80C in the “Next Gen Sequencing Libraries” box.

Read More

3’RACE - C.gigas 3’RACE for COX2

  • ~1 min read

Used Cg_COX2_3’RACE_short (SR ID: 1197) & Cg_COX2_3’RACE_long (SR ID: 1196) and the Clonetech SMART RACE cDNA Amplification Kit (unknown acquisition date) to attempt to acquire more 3’ sequence of the C.gigas COX2 isoform. Used Gigas 3’RACE cDNA (from 20080610).

Read More

NanoDrop1000 Comparison - Roberts vs. Young Lab

  • ~1 min read

A previous comparison was performed (see 20110209), but it was determined that the standard DNA being used to test the machines was old/degraded. Lisa ordered a new standard DNA dilutions series (Quant-iT dsDNA Kit; Invitrogen) and these DNAs were used. All DNAs were measured 5 times and were mixed by gently flicking between each measurement. A “blank” was measured between each different [DNA] and, if the reading was > + or - 1ng/uL, the machine was reblanked.

Read More

qPCR - Check DNased RNA BB01 for Residual gDNA (from earlier today)

  • ~1 min read

Ran qPCR on DNased RNA from earlier today to verify removal of contaminating gDNA. Used C.gigas 18s primers (SR IDs: 156, 157). 0.5uL (~40ng) of DNased RNA was used for testing. This corresponds, roughly, to the amount of sample that would be carried through to qPCR analysis of cDNA, assuming 1ug of RNA was used to make the cDNA (cDNA = 1000ng RNA/25uL = 40ng/uL, 1uL of cDNA in 25uL qPCR reaction). Positive control sample was ~25ng BB16 gDNA (from 20090519). Master mix calcs are here. Plate layout, cycling params, etc can be found in the qPCR Report (see Results). RNA was stored @ -80C in “Sam’s -80C Box”.

Read More

DNase - C.gigas BB01 (PROPS) RNA (from 20090507)

  • ~1 min read

Since the previous DNase treatment failed for this sample, will repeat but will start with less RNA (5ug instead of 10ug). Need more DNased RNA to finish repeating of PROPS. Some samples had insufficient quantities of DNased RNA remaining in BB01. Used 5ug of RNA and followed Ambion’s “rigorous” protocol, utilizing a total of 2uL of DNAse for each sample. Briefly, samples were incubated @ 37C for 30mins, an additional 1uL of DNase was added to each sample, mixed and incubated for an additional 30mins @ 37C. After finishing protocol, samples were spec’d.

Read More

qPCR - Check DNased RNA BB01 for Residual gDNA (from earlier today)

  • ~1 min read

Ran qPCR on DNased RNA from earlier today to verify removal of contaminating gDNA. Used C.gigas 18s primers (SR IDs: 156, 157). 0.75uL (~50ng) of DNased RNA was used for testing. This corresponds, roughly, to the amount of sample that would be carried through to qPCR analysis of cDNA, assuming 1ug of RNA was used to make the cDNA (cDNA = 1000ng RNA/25uL = 40ng/uL, 1uL of cDNA in 25uL qPCR reaction). Positive control sample was ~25ng BB16 gDNA (from 20090519). Master mix calcs are here. Plate layout, cycling params, etc can be found in the qPCR Report (see Results). RNA was stored @ -80C in “Sam’s -80C Box”.

Read More

DNase - C.gigas BB01 from 20110225

  • ~1 min read

Used EtOH precipitated BB01 RNA from 20110225 and followed Ambion’s “rigorous” protocol, utilizing a total of 2uL of DNAse. Briefly, samples were incubated @ 37C for 30mins, an additional 1uL of DNase was added to each sample, mixed and incubated for an additional 30mins @ 37C. After finishing protocol, samples were spec’d.

Read More

qPCR - Check DNased RNA BB01 for Residual gDNA (from earlier today)

  • ~1 min read

Ran qPCR on DNased RNA from earlier today to verify removal of contaminating gDNA. Used C.gigas 18s primers (SR IDs: 156, 157). 0.5uL (50ng) of DNased RNA was used for testing. This corresponds, roughly, to the amount of sample that would be carried through to qPCR analysis of cDNA, assuming 1ug of RNA was used to make the cDNA (cDNA = 1000ng RNA/25uL = 40ng/uL, 1uL of cDNA in 25uL qPCR reaction). Positive control sample was ~25ng BB16 gDNA (from 20090519). Master mix calcs are here. Plate layout, cycling params, etc can be found in the qPCR Report (see Results). RNA was stored @ -80C in “Sam’s -80C Box”.

Read More

DNase - C.gigas BB01 from 20110216

  • ~1 min read

Used EtOH precipitated BB01 RNA from 20110216 and followed Ambion’s “rigorous” protocol, utilizing a total of 2uL of DNAse. Briefly, samples were incubated @ 37C for 30mins, an additional 1uL of DNase was added to each sample, mixed and incubated for an additional 30mins @ 37C. After finishing protocol, samples were spec’d.

Read More

Ethanol Precipitation - DNased RNA BB01 (from earlier today)

  • ~1 min read

Due to residual gDNA contamination, will EtOH precipitate in order to treat with DNase again. Add 0.5 vols 3M NaAOc (pH = 5.2), 2.5 vols 100% EtOH, mixed and incubated @ -20C for 30mins. Pelleted RNA @ 16,000g, 4C 30mins. Washed RNA with 1mL 70% EtOH (2x due to fear of residual salts from DNase Buffer). Pelleted RNA @ 16,000g, 4C, 15mins. Resuspended RNA in 45uL nuclease-free H2O. Sample was stored @ -80C (in “Sam’s RNA Box #1) until it could be DNased again.

Read More

qPCR - Check DNased RNA BB01 & 09 (from earlier today)

  • ~1 min read

Ran qPCR on DNased RNA from earlier today to verify that it was free of contaminating gDNA. Used C.gigas 18s primers (SR IDs: 156, 157). 0.5uL (50ng) of DNased RNA was used for testing. This corresponds, roughly, to the amount of sample that would be carried through to qPCR analysis of cDNA, assuming 1ug of RNA was used to make the cDNA (cDNA = 1000ng RNA/25uL = 40ng/uL, 1uL of cDNA in 25uL qPCR reaction). Positive control sample was ~25ng BB16 gDNA (from 20090519). Master mix calcs are here. Plate layout, cycling params, etc can be found in the qPCR Report (see Results). RNA was stored @ -80C in “Sam’s -80C Box”.

Read More

DNase - C.gigas BB/DH (PROPS) RNA (from 20090507)

  • ~1 min read

Need more DNased RNA to finish repeating of PROPS. Some samples had insufficient quantities of DNased RNA remaining in BB01 and BB09. Used 10ug of each RNA and followed Ambion’s “rigorous” protocol, utilizing a total of 2uL of DNAse for each sample. Briefly, samples were incubated @ 37C for 30mins, an additional 1uL of DNase was added to each sample, mixed and incubated for an additional 30mins @ 37C. After finishing protocol, samples were spec’d.

Read More

Data Analysis - Young Lab ABI 7300 Calibration Checks

  • 2 min read

All runs (3 runs were conducted) were created using a master mix containing C.gigas gDNA (either 50ng or 100ng), 1X Promega qPCR Master Mix, 0.2uM each of forward/reverse primers (18s; Roberts SR ID: 156, 157). The master mix was mixed well and 10uL were distributed in each well of ABI plates. Plates were sealed with ABI optical adhesive covers.

Read More

NanoDrop1000 Comparison - Roberts vs. Young Lab

  • 2 min read

Due to an apparent reduction in assay sensitivity for the Hematodidium qPCR assay, we have decided to determine if the spec readings of the plasmid DNA being used for the standard curves are accurate. Used C.gigas gDNA and the lambda DNA Standard (100ng/uL) included in the Quant-iT PicoGreen dsDNA Assay Kit (Invitrogen) that was marked as received 9/1/10. Tested both the Roberts Lab and Young Lab using these DNAs. At least 6 separate measurements were taken of each DNA on each machine. Samples were briefly mixed by flicking the tube 4-5 times prior to each measurement.

Read More

qPCR - Test Young Lab qPCR Calibration (Repeat)

  • ~1 min read

This is a repeat of a run from 20110204. Here’re master mix calcs. This was being repeated to evaluate whether or not the relative differences in Ct values observed on 20110204 are consistent or not across the plate. Cycling params were as follows:

Read More

qPCR - Test Young Lab qPCR Calibration (Repeat)

  • ~1 min read

This is a repeat of an earlier run from today, but with a different qPCR plate. [Here’re master mix calcs (bottom half of page)(https://eagle.fish.washington.edu/Arabidopsis/Notebook%20Workup%20Files/20110204-01.jpg). Cycling params were as follows:

Read More

qPCR - Test Young Lab qPCR Calibration

  • ~1 min read

Recently, the Young Lab’s ABI 7300 qPCR machine was calibrated. Steven asked me to run a plate and see how well the calibration worked. Ran a plate with C.gigas gDNA and Gigas 18s primers (SR ID: 156 and 157) that are known to amplify gDNA. [Master mix calcs are here (top half of page)(https://eagle.fish.washington.edu/Arabidopsis/Notebook%20Workup%20Files/20110204-01.jpg). Cycling params were as follows:

Read More

Gigas Bacterial Challenge - 1hr & 3hr Challenges with Vibrio vulnificus

  • ~1 min read

400mL O/N culture (1x LB+1% NaCl, 37C, 150RPM, 1L flask) of V.vulnificus (STRAIN??) and V.tubiashii (Strain: RE22) were pelleted (4300RPM, 25C, Sorvall ST-H750 rotor). Supe was removed and pellets were each resuspended in 50mL sea water. 1mL was taken from each to use for dilutions to determine colony forming units (CFU).

Read More

Back to Top ↑

2010

qPCR - COX qPCR Vibrio Exposure Response Check

  • ~1 min read

Used COX primers (SR IDs 1060, 1061) and cDNA from 20080327, which consisted of 7 control gigas gill and 7 vibrio-exposed (24hrs) gigas gill samples, labeled as C# and VE#, respectively. The experiment was a 24hr. exposure live Vibrio vulnificus, parahaemolyticus Cf = 2.055x10^11 (6.85x10^7 Vibrio cells/oyster). Note: Used a free sample of 2x Brilliant III Ultra Fast SYBR Green QPCR Master Mix (Stratagene) for this qPCR. Mixed components and set up cycling params according to the manufacturer’s recommendation for the BioRad CFX96.

Read More

Restriction Digestions - HpaII and MspI on Mac’s C.gigas Samples: Round 2

  • ~1 min read

Continued with 2nd round of digestions from yesterday. All samples were resuspended in 25uL of H2O yesterday, so brought volume up to 44uL with H2O, added 5uL of appropriate 10X Buffer (HpaII = NEB Buffer #4, MspI = NEB Buffer #1), added 1uL of enzyme, incubated 37C for 3hrs. Heat-inactivated all samples @ -80C for 30 mins.

Read More

Phenol:Chloroform Extractions and EtOH Precipitations - HapII and MspI digests from yesterday

  • ~1 min read

Restriction digests from yesterday were mixed with equal volume (50uL) of phenol:chloroform:IAA (25:24:1) and centrifuged 16,000g for 5mins @ 4C. Aqueous phase was transferred to a clean tube and an equal volume (50uL) of chloroform was added. Samples were mixed and centrifuged 16,000g for 5mins @ 4C. Aqueous phase was transferred to clean tubes and EtOH precipitated, according to protocol. Samples were resuspended in 25uL of H2O and spec’d.

Read More

QPX Washes

  • ~1 min read

Washed 4 day old QPX cultures. 3 isolates (S-1, TD-81, ATCC), two flasks (13mL) of each were washed in the following manner:

Read More

gDNA Isolation

  • 1 min read

Isolated gDNA from gray whale skin, human cheek cells (my own!) and two different species of algae (species 1, species 2) using Qiagen’s DNEasy Blood & Tissue Kit according to protocol. Incubated all samples at 55C for 1hr. Eluted DNA with 50uL of Buffer AE. Spec’d samples on NanoDrop 1000.

Read More

EtOH Precipitation - Whale gDNA from 20101022

  • ~1 min read

Precipitated whale gDNA in hopes of producing a sample with a higher concentration. Added 0.1 vols of 3M NaOAc (10uL), 2.5 vols of 100% EtOH (275uL), mixed thoroughly and incubated @ -20C for 1hr. DNA was pelleted by spinning sample @ 16,000g, 30mins, 4C. No visible pellet. Supe was removed, sample was washed with 1mL 75% EtOH, and pelleted by spinning @ 16,000g, 15mins, 4C. Supe was removed, sample resuspended in 10uL nuclease-free H2O and spec’d.

Read More

gDNA Isolation

  • ~1 min read

Isolated gDNA from crab (unknown species), starfish exposed to RoundUp (unknown species) and gray whale blubber using Qiagen’s DNEasy Kit, according to manufacturer’s protocol. Tissue was incubated at 55C with Proteinase K for 1hr. gDNA was eluted with 100uL of Buffer AE and spec’d.

Read More

qPCR - Test Plate for Opticon 2

  • ~1 min read

Ran a full plate for testing well-to-well consistency (or, inconsistency!) of the Opticon 2, since it’s been behaving poorly lately. This will provide us with an idea of whether or not the oddities that we’ve been witnessing have any effect on our actual data.

Read More

DNase - DNasing Hard Clam RNA from yesterday

  • ~1 min read

Pooled 2ug of each sample in each group (MAX, CA, MA) for a total of 6ug of RNA (3 total samples), brought volume up to 50uL and DNased using Ambion’s Turbo DNA-free following the rigorous protocol. Calcs can be seen here. Spec’d:

Read More

EtOH Precipitation - Hard Clam RNA from earlier today

  • ~1 min read

RNA was mixed with 0.1 vols of 3M NAOAc (pH = 5.2) and 2.5 vols of 100% EtOH, vortexed and incubated @ -20C for 30mins. RNA was pelleted @ 16,000g, 30mins, 4C. Supe was discarded and pellet was washed with 1mL 70% EtOH. RNA was pelleted @ 16,000g, 15mins, 4C. This was step was repeated a second time. Supe was discarded, the RNA was resuspended in 50uL of 0.1% DEPC-H2O, spec’d and stored @ -80C:

Read More

Package - Hard Clam Samples from MBL

  • ~1 min read

Rec’d package from Scott Lindell @ MBL containing 65 screw cap tubes in a white microtube rack. All tubes are tissues in RNA Later (presumably). One sample (MA4-5) was lost during a brief centrifugation to get tissue sample unstuck from top of tube and in to RNA Later solution. The head of the tube snapped off and the entire tube/sample was obliterated in the rotor. Also, it appears as though all the tubes leaked RNA Later solution during transport. Samples were temporarily stored @ 4C and will be catalogued/transferred to -80C.

Read More

Package - Hard Clam Samples from Rutgers

  • ~1 min read

Rec’d package of hard clam samples from Emily @ Rutgers on wet ice. Package contained numerous 1.5mL snap cap tubes separated in to groups in zip lock bags. Stored temporarily @ 4C. Will catalog and then store @ -80C.

Read More

gDNA Isolation - Various gigas samples (continued from yesterday)

  • ~1 min read

Pelleted residual tissue 10mins @ 10,000g @ RT. Transferred supe to new tubes. Precipitated DNA with 0.25mL 100% EtOH. Incubated 3mins @ RT. DNA was pelleted 5mins @ 5000g @ RT. Supe was removed, pellets were washed with 1mL 75% EtOH (x2). Supe was fully removed and the DNAs were resuspended in 300uL 8mM NaOH (made 7/9/10 SJW).

Read More

gDNA Isolation - Various gigas samples

  • ~1 min read

Placed ~20mg fragments of tissue in 250uL DNAzol. Added 1.35uL of Proteinase K (Fermentas; 18.5mg/mL) to reach a final concentration of 100ug/mL. Incubated RT, O/N, end-over-end rotation. Will complete DNA isolation tomorrow.

Read More

MeDIP - SB/WB Fragmented gDNA EtOH precipitation (continued from 20100702)

  • 1 min read

Finished EtOH precipitation of MeDIP gDNA. Samples were pelleted 16,000g, 4C, 30mins. Supe was discarded. Washed with 1mL 70% EtOH, pelleted 16,000g, 4C, 15mins. Supe discarded. MeDIP DNA was resuspended in 100uL of TE (pH = 8.5). Wash samples, containing unmethylated DNA, were resuspended/combined in a total of 100uL TE (pH = 8.5). Samples were spec’d:

Read More

Restriction Digests - Various gigas gDNAs of Mac’s

  • ~1 min read

Performed restriction digests. Made dilutions of all DNAs involved of 25ng/uL. Made enough for a total of 9 digests could be performed on each DNA. This allowed using 10uL of each DNA for each rxn, more mileage out of the lowest concentration sample (R37-01), and allowed for the use of master mixes when preparing the digests. All calculations/dilutions/master mixes can be seen here. Each DNA was digested individually with HpaII, MspI and undigested. Incubated the digests 4hrs @ 37C. After digestion, performed an EtOH precipitation. Added 0.1 vols of 3M NaOAc (pH=5.2), then 2.5 vols of 100% EtOH. Mixed by inversion and incubated 30mins @ -20C. Pelleted DNA 16,000g, 30mins @ 4C. Discarded supe. Washed pellets with 1mL 70% EtOH. Pelleted DNA 16,000g, 15mins, 4C. Discarded supe. Resuspended DNA in 10uL PCR H2O and spec’d.

Read More

MeDIP - SB/WB Fragmented gDNA (from 20100625)

  • ~1 min read

After confirming proper fragmentation (~460bp average fragment size) via Bioanalyzer earlier today, began the MeDIP process. Brought fragmented DNA samples up to 350uL with TE. Heated samples @ 95C for 10mins, then incubated on ice 5mins. Added 100uL of 5x MeDIP Buffer (50mM Na2HPO4, 700mM NaCl, 0.25% Triton-X 100), 45uL of TE and 5uL (5ug) of anti-methyl cytidine antibody (Diagenode; 5-mC monoclonal antibody cl. b). Incubated O/N, 4C rotating.

Read More

gDNA Sonication - SB/WB gDNA pools (prep for MeDIP) from 20100618

  • ~1 min read

The previous attempt at sonication (see 20100618) failed, likely due to no using the correct equipment (tubes and Covaris adapter). The two gDNA pools, which had previously been unsuccessfully fragmented on 20100618 (SB and WB) were sonicated using a Covaris S2. Used the guidelines of the manufacturer (listed below) for shearing gDNA to a desired target size (500bp):

Read More

gDNA Precipitation - SB/WB gDNA pools (prep for MeDIP)

  • 1 min read

8 gDNA samples from SB were pooled and 8 gDNA samples from WB were pooled, using equal amounts of gDNA from each sample (1250ng) for a total of 10ug (see SB/WB Mac’s MeDIP spreadsheet for specific samples/volumes used in pooling). Since samples were stored in pH-adjusted NaOH (see 20100605), they needed to be precipitated in order to have the gDNA suspended in TE for the downstream steps of methylated DNA immunoprecipitation (MeDIP). 10% 3M sodium acetate (pH = 5.2) was added to each tube, then 2.5 vols of 100% EtOH and mixed. Samples were incubated @ -20C for 30mins. DNA was pelleted by spinning 16,000g for 30mins @ 4C. Supe was discarded. Pellets were washed with 1mL 70% EtOH and then pelleted @ 16,000g for 10mins @ 4C. Supe was discarded and gDNA was resuspended in 120uL of TE (pH = 8.0) and spec’d.

Read More

gDNA Isolation - Mac gigas gill samples (continued from yesterday)

  • 1 min read

Continued with gDNA isolation from yesterday’s samples. Samples were gently pipetted up and down to further dissolve remaining tissue, although tissue did not dissolve entirely. Pelleted residual tissue 10mins @ 10,000g @ RT. Transferred supe to new tubes. Precipitated DNA with 0.25mL 100% EtOH. Incubated 3mins @ RT. DNA was pelleted 5mins @ 5000g @ RT. Supe was removed, pellets were washed with 1mL 75% EtOH (x2). Supe was fully removed and the pellets were resuspended in 200uL 8mM NaOH (made by Amanda Davis 5/20/10).

Read More

gDNA Isolation - Mac gigas gill samples (continued from yesterday)

  • 2 min read

Continued with gDNA isolation from yesterday’s samples. Additionally, isolated gDNA from R51 01, but homogenized the tissue (using disposable 1.5mL mortar/pestle) in 0.5mL of DNAzol and topped off to 1.0mL. All 3 samples were gently pipetted up and down to further dissolve the tissue. For those samples that were subjected to Proteinase K digestion, I transferred 100uL of the solution to a new tube containing 1mL of DNAzol, [as described in the DNAzol protocol (see “Notes, #5” part of protocol)(https://www.mrcgene.com/dnazol.htm). Tubes were incubated 10mins @ RT.

Read More

Package Rec’d - From NOAA in Connecticut

  • ~1 min read

Rec’d 6 15mL conical tubes with liquid cultures of various algae. It appears that we rec’d two of each culture. No note/info included with package. Tubes will be stored @ RT in the styrofoam container they arrived in. Tube labels are listed below:

Read More

SOLiD ePCRs - Yellow perch CT, WB and lake trout Lean libraries

  • ~1 min read

Performed ePCRs on these samples from DATE, following the “full scale” protocol. A work flow analysis (WFA) run on these samples from the initial ePCRs/templated bead prep (DATE) revealed too many polyclonal beads, thus requiring them to be redone. ePCRs will be performed using 1.0pM (120pg/uL) of the SOLiD cDNA fragment libraries, instead of the 1.5pM (180pg/uL) used previously.

Read More

Package - Hard Clam gill tissue/hemolymph in RNA later

  • ~1 min read

Rec’d package from Rutgers (Emily Pearson) containing two large Ziplock bags on “wet” ice, each of those containing smaller bags with sample tubes in them. One large bag contains gill tissue samples and the other large bag contains hemolymph samples. Samples will temporarily be stored @ 4C until they can be catalogued and boxed by Lexie later today.

Read More

qPCR - V.tubiashii primers test (Vpt A and Vt IGS)

  • 1 min read

Utilized to sets of primers obtained from the Friedman Lab: VptA (referred to as “Hasegawa”, even though the reference article calls the primers Vtp A) and Vt IGS (referred to as “Lee” primers, presumably from a published article). For template, used “RE22 DNA” that was given to me by Elene. Tube is dated 9/10/09 and has no indication of concentration. Performed qPCR on a set of 10-fold dilutions. Plate layout/qPCR set up is here, along with dilution series used.

Read More

RNA Precipitation & mRNA Isolation for SOLiD Libraries - Pooled abalone total RNA: Carmel control, Carmel exposed

  • ~1 min read

RNA of 8 samples from each group was pooled equally from each individual. RNA was precipitated according to Ambion’s MicroPolyA Purist Kit. Used 0.1 volumes of 3M NaAOc, pH=5.2, 2.5vols of 100% EtOH and incubated 30min @ -80C. Pelleted RNA 16,000g, 30mins. Washed pellet w/70% EtOH and pelleted RNA 16,000g, 15mins. Pellets were resuspended in 50uL nuclease-free H2O and spec’d:

Read More

mRNA Precipitation for SOLiD - Perch, Lake Trout, & Herring mRNA (CONTINUED from yesterday)

  • ~1 min read

mRNA was pelleted and washed according to Ambion’s MicroPolyA Purist Kit. Pellets were resuspended in 8uL nuclease-free H2O and spec’d. 0.5uL was taken from each sample, transferred to a fresh tube, diluted to ~5ng/uL and stored @ -80C for eventual Bioanalyzer analysis. mRNA samples were stored @ -80C until we receive the Ribominus Concentration Module Kit from Invitrogen (turns out we didn’t have any!) for cleaning up the RNA after fragmentation.

Read More

SOLiD ePCR - Herring fragmented cDNA library: 3LHSITK09

  • ~1 min read

Due to low yield of templated beads (12x10^6) from the first run through (see SOLiD Bead Titration below), am repeating using 1.5pM of starting template (as opposed to 0.5pM used yesterday). It should be noted that there is NOT a linear relationship between the amount of starting template and the amount of enriched, templated beads one ends up with in this protocol. So, even though I am increasing the starting template by 3-fold, a 3-fold increase in the amount of enriched, templated beads is NOT expected (hopefully it’ll be more than that!).

Read More

SOLiD ePCR - Herring fragmented cDNA library: 3LHSITK09 (from 20091209)

  • ~1 min read

Processed herring fragmented cDNA library 3LHSITK09 (88.ng/uL) according to the ABI “Templated Bead Preparation Guide” following the “full-scale” protocol. Made a 1:1000 dilution (1uL library, 999uL 1x Low TE) = 88.5pg/uL. Mixed 67.8uL of this diluted sample with 32.2uL 1x Low TE to get a final concentration of 60pg/uL (500pM, according to ABI protocol). Oil phase used was previously prepared by Jesse (Seeb lab) in mid-December 2009. This oil phase is stable for 2 months @ 4C.

Read More

Back to Top ↑

2009

Reverse Transcription - BB & DH DNased RNA (from 20090514)

  • ~1 min read

Made a fresh, double batch (50uL rxn instead of 25uL) of cDNA according to Promega MMLV protocol using oligo dT primers. cDNA was put into a plate for faster qPCR loading. cDNA calcs and plate layout are here. Briefly, RNA and oligo dTs were combined, brought up to 37uL, heated @ 70C for 5mins and immediately placed on ice. RT master mix was made (RT master mix calcs are here), 13uL was distributed to each well. Samples were incubated @ 42C for 1hr and then 95C for 5mins.

Read More

PCR - Sepia cDNA

  • 1 min read

This is an exact repeat of the PCR from yesterday, due to inconsistencies between repeated PCRs from yesterday and earlier today. Here’s yesterday’s workup. Samples were stored @ 4C O/N after completion of PCR. Gell was run on 20091217.

Read More

PCR - Sepia cDNA and DNased RNA

  • 2 min read

Set up PCR on recent Sepia cDNA and DNased RNA samples using both S. officianalis_rhodopsin_F, R primers & Sep_op_F2, R2 primers. After yesterday’s intirguing PCR results, we need to confirm that the DNased RNA is free of contaminating gDNA. Additionally, we want to excise bands from the cDNA samples for sequencing. PCR set up is here. RNA was prepped as though making cDNA; diluted 0.2ug of DNased RNA in a final volume of 25uL. Used 1uL of this for PCRs.

Read More

PCR - Sepia cDNA (from yesterday)

  • 1 min read

Set up PCR on recent Sepia cDNA samples using both S. officianalis_rhodopsin_F, R primers & Sep_op_F2, R2 primers. PCR set up is here. Looking back at my old paper (gasp!) notebook from March 2007, I noticed that each primer set required differing amounts of Mg2+. Rhodopsin primers require 3mM Mg2+ in the PCR rxn and the opsin primers require 2mM Mg2+ in the PCR rxn. Mg2+ was added as required and is shown on the PCR set up link above.

Read More

Emulsion PCR - Herring Liver cDNA for SOLiD Libraries

  • ~1 min read

Emulsion PCR was performed with the two inner gel bands cut out earlier today according to the Ambio WTK protocol. PCR was run for 15 cycles. After the PCR, the samples were cleaned up using the Invitrogen PureLink PCR Micro Kit, according to the Ambion WTK protocol. The cleaned up cDNA (referred to as “libraries” from now on) was spec’d prior to running on the Bioanalyzer.

Read More

RNA Fragmentation - Herring Liver mRNA for SOLiD Libraries

  • 1 min read

Samples from 20091203. 0.5uL was removed from each and transferred to separate tubes and diluted to < 5ng/uL for subsequent Bioanalyzer analysis using the Pico chip. Samples were fragmented using RNase III according to the Ambion WTK protocol and then cleaned up/concentrated using the Invitrogen RiboMinus Concentration Module according to the Ambion WTK protocol.

Read More

RNA Isolation - Sepia samples

  • ~1 min read

Isolated RNA from 7 sepia samples received 20091125. Samples were removed from RNA Later, blotted and homogenized in 500uL of TriReagent. 500uL of additional TriReagent was added to the tubes after homogenization. Procedure was followed normally. The sepia retina RNA was isolated separately from the other samples and was resuspended in 100uL of 0.1% DEPC-H2O. The remaining samples were isolated and resuspended in 20uL of 0.1% DEPC-H2O. Nearly all samples had some sort of purple tint to them, ranging from almost black to extremely faint purple hue. The samples were spec’d and then stored @ -80C in Sam’s RNA Box #1.

Read More

Hard Clam Challenge - QPX Strain S-1 (continued from yesterday)

  • ~1 min read

All clams appeared to be alive and well. Most had their siphons out when I arrived to start collecting tissues. Clams were shucked after 24hr challenge. Gill and mantle samples were collected in separate 1.5mL snap cap tubes, stored briefly on ice and transferred to -80C in “Hard Clam QPX Challenge 12/2/2009.” box.

Read More

Hard Clam Challenge - QPX Strain S-1

  • ~1 min read

Challenged 2 FL hard clams and 1 BX hard clam with ~100uL of unwashed, 11 day old cultures. 2 FL hard clams and 1 BX hard clam received ~100uL of QPX media, as controls. Injections were done through the hinge using 20G1 needles and aimed for the pericardial cavity. After injections, clams were left out of water for 1.5hrs, then return to small containers of sea water. They will be incubated for 24hrs.

Read More

MBL Shipment - Hard Clam gill tissue in RNA Later

  • ~1 min read

Received samples from Scott Lindell today. Two Ziplock bags taped together labelled “11/16/09 Clams scudders.” The bags contain 2mL screw cap tubes with small tissue samples in RNA later. One group of tubes is labelled with FL-3 # and the other group with BX-4 #. Samples will be stored at 4C to be processed later this month.

Read More

MBL Shipment - Hard Clams

  • ~1 min read

Received hard clams from Scott Lindell today. Two bags. One group (4 live clams, 1 empty shell) labelled as “FL” and another group (9 live clams) labelled as “BX.” Clams were transferred to separate plastic shoebox containers with sea water and sand. They were stored at 15C until ready for experiment.

Read More

Herring 454 Data

  • ~1 min read

Data from MoGene was received today on two DVDs and one HDD. Data is two runs of two libraries, due to MoGene concerns that the data of the first run looked bad (too few reads). They performed a second run at no charge and provided us with that data as well.

Read More

MBL Shipment - MV oysters/cod

  • ~1 min read

Received a shipment of various MV oysters/cod samples from Scott Lindell at MBL. However, these were NOT shipped on dry ice! Samples were put @ -80C. Will be organized at a later date.

Read More

PCR - “Unknown” Dungans/Lyons

  • ~1 min read

This is a repeat of yesterday’s set up with LABY primers, but with an annealing temp of 53C in hopes of improving the number of amplicons generated from additional samples. See yesterday’s PCR run for info on samples.

Read More

PCR - “Unkown” Dungans/Lyons

  • 1 min read

This was done on the numbered tubes using the LABY A/Y primers for eventual sequencing. Turns out many of the tubes have some info (other than just a number) on their sides which might provide more information regarding which isolate they actually are. PCR set up is here. Annealing temp 55C.

Read More

Sequencing - Lake Trout HRM

  • ~1 min read

This is a second submission of 12 individuals from 8 primer sets. The previous sequencing run was botched because I used the combined primer plate instead of a single (forward or reverse) primer for submission.

Read More

RNA Precipitation - Herring gonad/ovary RNA (from 20091023)

  • ~1 min read

A subset (3 samples from each group) of samples were pooled (see spreadsheet, green-highlighted samples), each providing ~7.5ug of RNA, yielding 112.17uL. 0.1 vols of 3M NaOAC, pH = 5.2 were added to the tube (11.22uL). 2 vols of EtOH (246.8uL) was added to the tube. Tube was vortexed to mix and incubated @ -20C O/N.

Read More

RNA Precipitation - Herring Liver Samples

  • ~1 min read

A subset of samples (4 samples from each group) were pooled (see spreadsheet, green-highlighted samples), each providing ~68ug of RNA. The pooled sample was split into two tubes (435uL/tube). 0.1 vols (43.5uL) of 3M NaOAC (pH=5.2) were added, then 2 vols of 100% EtOH (957uL). Tubes were vortexed and incubated @ -80C for 30mins. RNA was pelleted by spinning 16,000g, 30mins, 4C. Supe was removed, pellets washed with 70% EtOH. Tubes were spun 16,000, 10mins, 4C. Supe removed. Pellets were resuspended in 250uL of RNase-free H2O and stored @-80C until Monday for mRNA isolation.

Read More

RNA Isolation - Herring Gonad/Ovary Samples

  • ~1 min read

From the Seeb Lab. Homogenized entire gonad/ovary samples in 5mL of TriReagent with the sonicator. In essence, based on the manufacturer’s recommendation, this means the ratio of tissue:TriReagent was ~2x. Transferred 0.5mL of homogenized gonad/ovary sample to 1.5mL snap cap tubes and added an additional 0.5mL of TriReagent, to adjust the ratio of tissue:TriReagent to ~1x. Samples were then stored @ -80C. These will be further processed tomorrow.

Read More

RNA Isolation - Herring Liver Samples

  • ~1 min read

RNA was isolated according to protocol. Pellets were resuspended in 200uL of 0.1%DEPC-H2O, heated @ 55C for 5 mins, spec’d and stored @ -80C in the “Herring RNA Box #1”.

Read More

RNA Isolation - Herring Liver Samples (LHPWS09 1-6)

  • ~1 min read

From Seeb Lab. Homogenized entire liver samples in 5mL of TriReagent with the Tissue Tearers. In essence, based on the manufacturer’s recommendation, this means the ratio of tissue:TriReagent was ~2x. Transferred 0.5mL of homogenized liver sample to 1.5mL snap cap tubes and added an additional 0.5mL of TriReagent, to adjust the ratio of tissue: TriReagent to ~1x. Samples were then stored @ -80C. These will be further processed once all remaining liver samples have been homogenized inTriReagent.

Read More

DNase Treatment - Tim’s adult gigas challenge RNA (from 20090930)

  • ~1 min read

Used 5uL of RNA from each sample, brought samples up to 50uL with H2O and treated according to Ambion’s Turbo DNA-free kit. Rigorous protocol was followed (1.5uL DNase initially + 1.5uL additional DNase after 30mins). Transferred treated samples to a PCR plate to facilitate further manipulation of the samples. Will perform qPCR on these samples to make sure treatment worked.

Read More

DNase Treatment - Tim’s adult gigas challenge RNA (from 20090930)

  • ~1 min read

Used 5uL of RNA from each sample, brought samples up to 50uL with H2O and treated according to Ambion’s Turbo DNA-free kit. Transferred treated samples to a PCR plate to facilitate further manipulation of the samples. Will perform qPCR on these samples to make sure treatment worked.

Read More

Ribosomal-depleted RNA - Rick’s trout RBC samples for the SOLiD WTK

  • 1 min read

Prior to starting the procedure, 0.5uL of total RNA was removed from each sample (control, polyI:C), diluted to ~5ng/uL. 1.5uL of each of these was transferred to a 0.5mL snap cap tube for running on the PicoChip on the Bioanalyzer. These were stored @ -80C in the “Bioanalyzer Samples” box.

Read More

mRNA Isolation - Rick’s trout RBC samples previously treated with Ribominus Kit (by Mac)

  • ~1 min read

Was given ~0.5ug of each of these two RNA samples and processed them with Ambion’s microPolyA Purist Kit according to protocol. After elution, the samples were EtOH precipitated @ -80C for 30mins, pelleted 30mins 16,000g for 30mins, 4C. Supe removed, RNA washed with 1mL 70% EtOH and spun 10mins 16,000g, 4C. Supe removed. Resusupended in 8uL of The RNA Storage Solution and spec’d.

Read More

mRNA Isolation - Gigas BB and DH samples previously treated with Ribominus Kit (by Mac)

  • ~1 min read

Was given ~0.5ug of each of these two RNA samples and processed them with Ambion’s microPolyA Purist Kit according to protocol. After elution, the samples were EtOH precipitated @ -80C for 30mins, pelleted 30mins 16,000g for 30mins, 4C. Supe removed, RNA washed with 1mL 70% EtOH and spun 10mins 16,000g, 4C. Supe removed. Resusupended in 10uL of The RNA Storage Solution and gave back to Mac.

Read More

mRNA Isolation - Gigas BB and DH samples previously treated with Ribominus Kit (by Mac)

  • ~1 min read

Was given 1ug of each of these two RNA samples and processed them with Promega’s PolyA Tract Kit according to protocol. After elution, the samples were EtOH precipitated @ -20C for 30mins, pelleted 30mins 16,000g for 30mins, 4C. Supe removed, RNA washed with 1mL 70% EtOH and spun 15mins 16,000g, 4C. Supe removed. Resusupended in 15uL of 0.1% DEPC-H2O and spec’d.

Read More

HRM - Lake Trout SNPs (HRM-white-01)

  • 1 min read

The following primers from primer plate LTP01 will be used for analysis of Rick’s Lake Trout DNA plate (from 4/28/2009): A1, C1, H1, B2. So, that’s 4 primer sets x 96 DNA samples = 384. HRM set up is here. A 1:10 dilution plate of Rick’s Lake Trout DNA1 plate (from 4/28/2009) was made for HRM. This means approximately 20ng of DNA used in each rxn. The robot was used to add 1uL of DNA from the 96-well plate to the appropriate wells of the 384-well HRM rxn plate. Plate was spun to collect the DNA at the bottom of the wells. The wells were visually inspected to ensure that each received the DNA. 1uL of DNA was manually added to those wells that did not receive sample (B23, C23).

Read More

Primers - Lake Trout Primers for HRM

  • ~1 min read

The two primer plates (LTP01F, LTP01R) were received today. Primers (supplied as 10 nmoles of each) will be reconstituted with 100uL of PCR H2O to make a Cf of 100uM. Forward and reverse primers will be combined in a new plate, in equal volumes, to give a Cf of 50uM. These combined primers will be used to test them on pooled lake trout DNA to identify functional primer pairs for use in HRM.

Read More

qPCR - Recalibration of Opticon 2

  • ~1 min read

According to the Bio-Rad rep that analyzed the calibration test on 20090824, recalibration might be a good idea. As such, we’ll do that. Old calibration file was found and backed up prior to proceeding, as generation of a new calibration file would replace the old one.

Read More

qPCR - Additional Calibration test of Opticon 2

  • ~1 min read

Based on recs from Bio-Rad rep (Carl Fisher), will repeat Opticon 2 calibration (see 20090813) test according to Opticon manual. Then, will rotate plate 180 degrees and repeat test and upload data to Bio-Rad server for analysis and evaluation.

Read More

qPCR - Carita Primer Test for High Resolution Melt (HRM) Curve Analysis

  • ~1 min read

Ran a qPCR on Rick’s Lake Trout DNA from 4/28/2009 using primers in Carita’s CMA01 Primer Plate (Excel file). DNA was pooled (2uL from each sample), spec’d and diluted to 10ng/uL. qPCR set up is here. Plate layout matches Carita’s primer plate layout. Since we’re just looking for positive/negative samples, I ran this on the Opticon 2 despite the recent “problems” we’ve been having with it. Cycling params used with the 2x HRM M.M. are as follows:

Read More

qPCR - Calibration test of Opticon 2

  • ~1 min read

Received new FAM calibration reagent. It comes pre-prepared in a 1x PCR buffer (0.3uM), however there is only enough for a single plate (use 50uL/well). Will run plate in Opticon 2. Run according to the calibration protocol in the Opticon 2 manual (p. 10-4).

Read More

qPCR - Calibration test of Opticon 2

  • ~1 min read

Due to results of Opticon testing from 20090722, we have acquired FAM Calibartion Dye from Bio-Rad. Although not listed online or on the product itself, Bio-Rad customer service informed me that the concentration = 1mM. The calibration protocol in the Opticon 2 manual (p. 10-4) says to use 0.3uM (Cf) in 50uL. Will follow this info. Made up 15mLs of dye solution and distributed 50uL into each well of 3 plates. Tested all three plates on two different machines (Opticon 2 and Friedman lab’s).

Read More

Bacteria - C.pugetti culture (from 20090713)

  • ~1 min read

1L liquid culture (grown for 10 days) was split into two UV-sterilized bottles. Cells were pelleted in a Sorvall T21 centrifuge using the bucket rotor for 30mins @ 4200RPM, 4C. Supe was removed and bacterial pellets were stored @ -20C.

Read More

qPCR - Gigas DNA for Opticon testing

  • ~1 min read

Due to some weird anomolies seen during my previous qPCRs with the H.crach RNA/cDNA samples (positive controls produced good fluorescence when tested in Column 1 of the Opticon, but consistently failed to produce virtually any fluorescence when in Column 6 of the Opticon), I’ve decided to check the Opticon’s fluorescence detection.

Read More

qPCR - Abalone gDNA (H.crach 06:7-1)

  • ~1 min read

This is to test (again!) the H.crach_h-1fg_intron primers and obtain a working positive control. This gDNA is from Lisa/Nate. Acquired from them 20090717. Don’t know date/method of isolation, but this should be good, recent gDNA. qPCR plate layout/set up is here. Anneal temp 50C. Ran serial dilutions of the gDNA: undiluted, 1:10 and 1:100.

Read More

qPCR - Abalone cDNA (07:12 set from 3/3/2009 by Lisa) and DNased RNA (from 20090623)

  • ~1 min read

This is nearly a repeat of the qPCR earlier today due to the fact that the positive control never amplified. This is being done to check whether or not there is gDNA contamination in these cDNA and DNased RNA. Will use H.crach_h-1fg_intron primers. In hopes of remedying the positive control issue, I have used three sets of gDNA and used 5uL instead of the usual 1uL for their respective reactions. qPCR plate layout/set up is here. Anneal temp 50C.

Read More

qPCR - Abalone gDNA

  • ~1 min read

Used up the remainder of the one positive control gDNA that worked with all the primers in yesterday’s reaction (H.crach_h-1fg_intron, H.iris_actin_intron, H.crach_16s), so need to find a new set of gDNA to use for future positive controls. qPCR plate layout/set up is here. Anneal temp 50C. Used the following gDNA with :

Read More

DNA Precipitation CONTINUED - Dungan MIE-14v gDNA from yesterday

  • ~1 min read

Sample was pelleted by spinning in a microcentrifuge @ max speed, 4C for 30mins. Supe was removed and sample CAREFULLY washed with 1mL 70% EtOH. Sample was spun in a microcentrifuge @ max speed, 4C for 10mins. Supe was removed, sample brought up in 10uL of TE and spec’d.

Read More

PCR - Bay/Sea Scallop DNA

  • 1 min read

An additional attempt to get the actin primers to work for use in screening samples for bay/sea scallop hybrids. The scallop_actin_fw primer was used in conjunction with the following:

Read More

gDNA Isolation - Dungan isolate MIE-14v

  • 1 min read

Cells stored in EtOH were pelleted 5000g, 10mins, 25C. A brownish smear was present along the inside of the tube after spinning; not really a pellet per se. Supe was removed and cells were washed twice with 1X PBS. The smear was reduced to a pellet after the first wash in PBS. The second wash resulted in a slightly smaller pellet, but a pellet was present nonetheless before proceeding. Cells were subjected to an enzymatic lysis in 180uL of a TE/Triton X-100/lysozyme mixture as described in the Qiagen DNeasy Kit for Gram-Positive Bacteria (and for cells having substantial cell walls). Cells were incubated in this mixture for 30mins @ 37C. 25uL of proteinase K and 200uL of Buffer AL were then added and the mixture was incubated @ 70C for 30mins. Protocol then followed the “normal” steps for isolation of gDNA. Sample was eluted in 100uL of Buffer AE and then spec’d.

Read More

qPCR - MV hemocyte cDNA from 20090614

  • ~1 min read

Set up qPCR with Cv_18s_F/R primers on the following samples that had previously come up negative in both reps using the diluted (1:20) cDNA that Mac had made specifically for the 18s runs:

Read More

Spec Reading - C.pugetti gDNA from 20090526

  • ~1 min read

A recent email from JGI indicates that they are satisfied with the quality of DNA (as seen on 20090601), however their estimate of the gDNA concentration (42ng/uL) means that we have ~16ug of DNA. They requested 50ug. Based on the gel, their calculations are reasonable. However, the NanoDrop suggests that are sample is ~1350ng/uL! So, I’ve respec’d the sample and did a few dilutions to see how it looked.

Read More

qPCR - MV hemocyte cDNA from 20090614

  • ~1 min read

Set up qPCR with Cv_18s_F/R primers on the following samples that had previously come up negative in both reps using the diluted (1:20) cDNA that Mac had made specifically for the 18s runs:

Read More

Bacteria - C. pugetti liquid cultures

  • ~1 min read

Inoculated 3 x 5mL Marine Broth + biphenyl crystals (UV sterilized) cultures from frozen stock in 50mL Falcon tubes. Incubated 200RPM, 28C. Will use these are starter cultures to inoculate larger cultures.

Read More

DNase Treatment - MV hemocyte RNA from yesterday

  • ~1 min read

Samples 3326: B23, A25, A22, B14, A21, A10 B22 came up positive for gDNA still. These were retreated according to Ambion protocol with a brand new Turbo DNA-free DNase kit. Additionally, I tested all three existing kits by “spiking” 19uL of H2O with 1uL (~200ng) of gigas gDNA; one tube for each kit and an untreated sample. Will qPCR to see if gDNA removal was successful.

Read More

PCR - C.pugetti gDNA from 20090526

  • 1 min read

This is a repeat of yesterday’s PCR due to the presence of bands in the water-only samples. Will use reagents and universal 16s bacterial primers (27F & 1492R) provide by the Horner-Devine lab in hopes of: 1) getting this two work and, 2) figuring out the source of the contamination.

Read More

PCR - C.pugetti gDNA from 20090513 & 20090526

  • ~1 min read

Previous PCRs from 20090601 & 20090602 both showed contamination in the negative control. Suspect that the primer stocks were contaminated due to the usage of older, non-sterile TE for reconstitution. New stocks were received and reconstituted with filter-sterilized TE. Working stocks were made with filter-sterilized Nanopure H2O. All pipettes, tips, tubes, racks were UV-sterilized in the biological hood. The PCR reaction was set up in the biological hood. PCR set up is here. Used universal 16s bacteria primers (27F, 1492R). Sequences from Sara Kelly. Anneal 60C.

Read More

DNase Treatment - Abalone Dg RNA isolated yesterday

  • ~1 min read

RNA from yesterday was treated according to Ambion Turbo DNA-free protocol to remove gDNA contamination. Work up is here. Will check for residual gDNA contamination once I’ve finished with another set of RNA isolations from the remainder of Abalone Dg tissue.

Read More

DNA Methylation Test - Gigas site gDNA (BB & DH) from 20090515

  • 1 min read

Used BB & DH samples #11-17 for procedure. Followed Epigentek’s protocol. My calcs for dilutions/solutions needed are here. All solutions were made fresh before using, except for Diluted GU1 which was made at the beginning of the procedure and stored on ice in a 50mL conical wrapped in aluminum foil. Used 100ng total (50ng/uL) of each sample gDNA. No standards for a standard curve based on speaking with Mac.

Read More

DNase Treatment - Oyster RNA from yesterday

  • ~1 min read

Yesterday’s qPCR indicated that all of the RNA still contained gDNA contamination. So, took 10ug of RNA from BB #1-10 and DH#1-10 (calcs/workup BB and DH) and brought the volumes up to 50uL with 0.1% DEPC-H2O. Processed the samples according to Ambion Tubrbo DNA-free protocol. Will proceed with qPCR immediately.

Read More

Bacteria - C. pugetti liquid cultures

  • ~1 min read

Started two 100mL cultures in 1x Marine Broth + biphenyl. One culture was inoculated from the original liquid culture (from 20090419) and the second was inoculated with a thick loopfull of C. pugetti from the plate (from 20090424). Cultures were incubated @ 28C, 200RPM.

Read More

Bacteria - C. pugetti liquid cultures

  • ~1 min read

Inoculated a total of 10, 5mL 1x Marine Broth in 50mL conicals. 5 tubes received 1mL of the original culture started on 20090419. 4 tubes received 1mL of the secondary culture (from 20090421). 1 tube was inoculated with a colony from the plate streaked on 20090424. Incubated all tubes @ 28C, 200RPM. Used a higher temp. to encourage faster/more robust growth.

Read More

Bacteria - C. pugetti plate (from 20090424)

  • ~1 min read

There appears to be growth on the plate. There is a large, bright yellow/chartreuse region on the plate where the streaking was initiated. Additionally, upon close inspection, it appears as though colonies can be seen.

Read More

Bacteria - C. pugetti liquid culture

  • ~1 min read

Results: It has now been 8 days since revival of the ATCC freeze dried culture. The media still looks a bit cloudy, but hasn’t really changed since the second or third day post-revival. Of note, there does seem to be an accumulation of clumps in the tube. These may or may not be clumps of cells. Will consult with Steven when he returns. Might need to pass cells and take some ODs to really assess changes in growth as these cells may not be as robust as E. coli or other common lab cultures.

Read More

Reverse Transcription - cDNA from DNased Abalone RNA from 20090420

  • ~1 min read

[Prepared cDNA using an equal amount of RNA from all samples (442.6ng)(https://spreadsheets.google.com/ccc?key=0AmS_90rPaQMzcHdyU1d0MDVMLWphMFdTOHUwVHFqWnc&hl=en). This amount was based on using the maximum allowable volume of RNA for the RT rxn AND the sample with the lowest [RNA] (08:3-20; 24.59ng/uL). cDNA was prepared according to the Promega MMLV RT recommendations. Here is the work up for the cDNA rxns. cDNA was stored @ -20C.

Read More

Bacteria - C. pugettii culture CONTINUED (from 20090419)

  • ~1 min read

Transferred 1mL of the culture to a 50mL conical containing 4mL of 1x Marine Broth and a couple crystals of biphenyl. Kept the cap loosened and incubated at 20C with shaking at 200RPM. Kept the existing culture in the incubator as well. No apparent growth.

Read More

Bacteria - C. pugettii culture

  • ~1 min read

Rehydrated ATCC isolate according to directions. Added 5mL of 1x Marine Broth to a glass culture tube. Used 1mL of this to rehydrate ATCC sample and then added back into the culture tube. Added a few crystals of biphenyl, which had been exposed to UV for ~5mins prior. Incubated at 20C, no shaking. This was done at ~11:30AM.

Read More

PCR - Old Dungan isolates #1-35 w/EukA/B primers

  • ~1 min read

Steven had me re-PCR the old Dungan isolates with the new EukA/B primers. Anneal temp 50C. [PCR set up here (bottom half of sheet)(https://eagle.fish.washington.edu/Arabidopsis/Notebook%20Workup%20Files/20090410-01.jpg) .

Read More

cDNA - Abalone RNA from 20090331 & 20090402

  • ~1 min read

cDNA was made from the above RNA samples using the Qiagen Quantitect RT Kit. The samples were laid out in a PCR plate. 274.2ng of RNA was used in the rxn for each sample, based on the lowest concentration RNA sample (08:3-20) to equalize all the samples. The Genomic Wipeout step of the kit requires 2uL of Genomic Wipeout enzyme/buffer to be added to 12uL of an RNA sample, so the calculations were done and can be found here. A check mark on the calculation sheet indicates that the water and then the RNA was added to the appropriate wells. Those with two check marks were used for a “No RT” rxn and thus, have duplicate wells (see plate layout).

Read More

mRNA Isolation - hard clam gill #1 DNased RNA from today

  • ~1 min read

DNased RNA from earlier today was split into four equal parts (175uL = 39.8ug). Three will be used for mRNA isolation and the fourth will remain as total RNA. Three of these were precipitated according to Ambion PolyAPurist Protocol: 1/10 volume 5M ammonium acetate, 1uL glycogen and 2.5 volumes of 100% EtOH. Incubated @ -80C for 30 mins. One sample was processed with the Promega PolyA Tract kit. The remaining two samples were processed according to PolyAPurist Protocol. Of those two, one of the samples was processed a second time to evaluate the effectiveness of running a sample through the PolyAPurist Protocol twice.

Read More

RNA Precipitation - Hard clam gill #1 RNA from 20080819

  • ~1 min read

DNAsed RNA using Ambion Turbo DNA-free kit, following the rigorous procedure. Diluted total RNA to 0.2ug/uL (Vf = 720uL). Added 1uL DNase and incubated the tube @ 37C for 30mins. Added an additional 1uL DNase and continued incubated for 30mins. Added 0.2 volumes of DNase Inactivation Reagent (158.4uL) and incubated at RT for 10mins with periodic mixing. Pelleted inactivation reagent according to protocol and transferred supe (DNA-free RNA) to clean tube.

Read More

mRNA Isolation - Hard Clam gill and hemo RNA

  • ~1 min read

mRNA was isolated according to Ambion PolyA Purist protocol. After mixing samples with resin, samples were incubated @ RT for 1hr. Samples were washed per the protocol. However, the hemo sample was not clearing from the spin columns with the protocol-directed 3 min. spins. The column had to be spun up to 15 mins. in order for the column to clear. :(

Read More

Bleeding/Tissue Collection - Hard Clams

  • ~1 min read

Hemos were collected from the remaining 12 clams as before and stored @ -80C. NOTE: 4 hemocyte samples were extremely cloudy. Possibly not hemos? Maybe gonad/d.g.? Gill tissue was collected from 5 clams and stored @ -80C.

Read More

RNA Isolation - Hard clam gill, hemos

  • ~1 min read

RNA was isolated from hard clam gill (0.08g; from 20090109) and from hard clam hemos (from 20090114). One “unknown” sample (from 20090114) was also processed. Pellets were resuspended in 50uL of 0.1%DEPC-H2O. Hemo samples were pooled. Samples were spec’d.

Read More

Bleeding - Hard Clams

  • ~1 min read

Bled 7 clams from 20090108 and 20090109. Bled clams using a 23g 1.5 needle on a 3mL syringe. Fluid was gathered and ranged from ~0.4-1.0mL. Hemolymph was transferred to individual 1.5mL snap cap tubes and spun @ 100g for 30mins @ 4C. Most of the supe was removed, but left ~100uL in each tube to avoid disturbing any pellet. Samples were stored @ -80C in the red box with previous hard clam hemo samples.

Read More

RNA - Precipitation continued from yesterday

  • ~1 min read

Transferred supe to a fresh tube and added 1mL 70% EtOH to remaining pellet. Spun samples max speed @ 4C 30 mins. Removed supe and washed pellets with 1mL 70% EtOH. Spun max speed 10 mins. Removed supe . Resuspended the “supe” sample in 50uL 0.1%DEPC-H2O and the “pellet” sample in 100uL 0.1%DEPC-H2O.

Read More

RNA - Reprecipitation of hard clam RNA from yesterday

  • ~1 min read

Because of the relatively large size of the pellets vs. the amount of RNA, I think another round of precipitation would be best to help remove additional residual salt carryover. Will precipitate O/N according to Ambion PolyA Purist protocol. RNA pellets were resuspended in 250uL of 0.1%DEPC-H2O and precipitated O/N @ -20C.

Read More

Bleeding - Hard Clams

  • ~1 min read

Bled 8 clams from 20090108 and 20090109, #4, 6, 8, 15, 16, 17, 21, 26. Bled clams using a 23g 1.5 needle on a 3mL syringe. Fluid was gathered and ranged from ~0.4-1.0mL. Hemolymph was transferred to individual 1.5mL snap cap tubes and spun @ 100g for 30mins @ 4C. Most of the supe was removed, but left ~100uL in each tube to avoid disturbing any pellet. Samples were stored @ -80C in the red box with previous hard clam hemo samples.

Read More

Bleeding - Hard Clams

  • ~1 min read

Bled 24 hard clams using a 23g 1.5 needle on a 3mL syringe. Fluid was gathered and ranged from ~0.4-1.0mL. Hemolymph was transferred to individual 1.5mL snap cap tubes and spun @ 100g for 30mins @ 4C. Most of the supe was removed, but left ~100uL in each tube to avoid disturbing any pellet. Samples were stored @ -80C in the red box wiht previous hard clam hemo samples. Clams were numbered and transferred to a holding tank. Gill and mantle tissue was collected from 10 of the clams. The collected tissue and the rest of the carcasses were stored @ -80C.

Read More

Bleeding - Hard Clams

  • ~1 min read

Bled 6 hard clams using a 23g 1.5 needle on a 3mL syringe. Fluid was gathered and ranged from ~0.4-1.0mL. Hemolymph was transferred to individual 1.5mL snap cap tubes and spun @ 100g for 30mins @ 4C. Most of the supe was removed, but left ~100uL in each tube to avoid disturbing any pellet. Samples were stored @ -80C in the red box with previous hard clam hemo samples. Clams were numbered and transferred to a holding tank.

Read More

PCR - Dungan Isolates

  • ~1 min read

Samples (in Chelex) were vortexed and heated @ 95C for 30mins with periodic vortexing. Tubes were spun max speed @ 4C for 2 mins to pellet Chelex. Set up PCR using Immomix master mix. Anealing temp. = 56C. PCR set up here.

Read More

PCR - Dungan Isolates

  • ~1 min read

All samples , except xCVC-11t, are already in Chelex. For xCvC-11t, pipetted a shunk of cells/tissue from source tube. Volume of liquid (EtOH) was ~75uL. Added this to screw cap tube containing 300uL of 10% Chelex solution. Vortexed and incubated @ 95C for 30mins. Vortexed and incubated other samples at 95C for 5mins. Set up PCR with AmpliTaq. Anneal temp. = 53C. PCR set up here.

Read More

SDS/PAGE, Western Blot - Test of HSP70 Ab on heat stressed shellfish for FISH441

  • 1 min read

Pacific oysters, a mussel, barnacles and a clam (sp. ?) were transferred from the holding tank to a large beaker with sea water which was placed into a 37C water bath. The shellfish were incubated in this water bath for ~3hrs. Tissues were collected from each, transferred to a 50mL conical tube and immediately placed in a dry ice/ethanol bath:

Read More

Back to Top ↑

2008

RNA Isolation - V. tubiashii from challenge (see 20081216)

  • ~1 min read

Added 10mL TriReagent to 2 x 50mL pellets (5.63 x 10^11 total bacteria; see calcs on 20081219) from the control samples collected on 20081219. Added 10mL TriReagent to 1 x 50mL pellet (1.835 x 10^12 total bacteria; see calcs on 20081219) from the V.tubi + oyster samples collected on 20081219. Scaled rest of RNA protocol to match. Resuspended pellets in 100uL 0.1%DEPC-H2O. Samples were NanoDropped.

Read More

Vibrio challenge CONTINUED (from yesterday)

  • ~1 min read

Significantly more bacteria in the container containing autoclaved oysters. Collected 2 x 50mL from each treatment. Collected ~750mL from each treatment. Cells were pelleted 4000RPM, 15mins, 4C. Supe was removed and pellets frozen @ -80C.

Read More

Vibrio challenge CONTINUED (from yesterday)

  • ~1 min read

500mL culture was split evenly between two containers containing 3L sterile sea water each. One container also contained 3 large, autoclaved C. gigas. Containers had an air stone to promote circulation. 4 x 1mL samples were collected from each container, pelleted @ 10,00RPM 1min. Supe removed and samples stored @ -80C. Samples will be collected @ t = 0, 0.5, 1.0 and 24 hrs. Containers were covered with aluminum foil to minimize splashing caused the by the air stone.

Read More

Vibrio challenge

  • ~1 min read

2X 10mL starter cultures of in 1x LB+1% NaCl were inoculated with two separate colonies of V. tubiashii and incubated O/N @ 30C 200RPM.

Read More

SDS/PAGE/Western - anti-HSP70 Ab Re-test

  • 1 min read

Another attempt to determine appropriate amounts of anti-HSP70 Ab [(ABR cat# MA3-006)(https://aquacul4.fish.washington.edu/Protocols:Information%20Sheets/Product%20Information%20Sheets/Antibodies/ABR%20-%20HSP70%20Ab.jpg)and/or protein needed for better detection of HSP70 in Gigas protein samples. Gigas gill protein extracts from 20080617 (both control and Vibrio exposure samples) were each pooled. The two samples were mixed with an equal volume of 2x sample reducing buffer. 100uL of hemolymph were extracted from Gigas muscles and mixed with an equal volume of 2x sample reducing buffer. Samples were boiled for 5mins. and loaded onto a Pierce 4-20% tris-hepes gel. Also loaded 10uL of SeeBlue ladder. Ran gel @ 150V for 45mins. Samples were transferred to nitrocellulose 20V for 30mins. Well locations were marked on the membrane with a pencil. Gel was stained with Coomassie stain for 30 mins and then destained with 10% acetic acid until bands were clearly visible.

Read More

SDS/PAGE/Western - anti-HSP70 Ab test CONTINUED (from yesterday)

  • ~1 min read

Primary Ab (anti-HSP70) solution was saved and stored in the 4C. The membrane was washed 3x 10 mins. w/1x TBS-T. 15mL blocking solution was added to membrane and incubated at RT for 10mins. Secondary Ab (DAM HRP) was added at a 1:2500 dilution and inubated at RT for 30 mins. Secondary Ab solution was discarded and membrane was washed 3x 10 mins. w/ 1x TBS-T and then developed with Millipore Immobilon Chemiluminescent reagent.

Read More

SDS/PAGE/Western - anti-HSP70 Ab test

  • 1 min read

Test of the new [anti-HSP70 Ab (ABR cat# MA3-006)(https://aquacul4.fish.washington.edu/Protocols:Information%20Sheets/Product%20Information%20Sheets/Antibodies/ABR%20-%20HSP70%20Ab.jpg). Gigas gill protein extracts from 20080617 (both control and Vibrio exposure samples) were each pooled to result in 10ug protein of control and 10ug protein of VE in a volume of 10uL each. The two samples were mixed with an equal volume of 2x sample reducing buffer. O. rubescans samples were taken from Rachel’s -20C box. 15uL of each sample was mixed with 2x sample reducing buffer. All samples were boiled for 5mins and spot spun. Samples were loaded onto Pierce 4-20% Tris-Glycine SDS/PAGE gels. 10uL of SeeBlue ladder was loaded. Gel was run @ 150V for 45mins.

Read More

SDS/PAGE/Western - Purified (His column) FST samples from 20081112

  • 1 min read

10uL of each sample from 20081112 (binding supe, washes and elution fractions) were mixed with 2x sample reducing buffer and boiled 5 mins. Samples were loaded onto Pierce 4-20% Tris-Glycine SDS/PAGE gels. 10uL of SeeBlue ladder was loaded. 5uL of positive control lysate was loaded. Gel was run @ 150V for 45mins.

Read More

Western Blot - Purified (His column) decorin, FST, LAP & telethonin

  • 2 min read

10uL of each sample from yesterday (binding supe, washes and elution fractions) were mixed with 2x sample reducing buffer and boiled 5 mins. Samples were loaded onto Pierce 4-20% Tris-Glycine SDS/PAGE gels. 10uL of SeeBlue ladder was loaded. 5uL of positive control lysate was loaded. Gels were run @ 150V for 45mins.

Read More

Back to Top ↑