This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
printf "\nINDEL.profiler\n\n usage: ./INDEL.profiler.sh READs.fasta Amplicon.seq.fasta\n\n" | |
cat $1 | \ | |
while read l; do | |
printf " \n" | |
read L | |
echo $l $L | sed 's/ /\n/g' | cat - $2 | muscle -quiet | fasta_formatter | \ | |
while read c; do | |
printf "\n"$c"\nDEL:\n" | |
read d; |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
# counting RNA-seq reads | |
# similar results with htseq-count w/ "UNION" | |
featureCounts -T 35 -p -t exon -g rmsk_id -a L1.ERV1.ERVK.ERVL.MaLR.gtf -o featureCounts.results \ | |
sample1.bam sample2.bam sample3.bam |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
source("https://bioconductor.org/biocLite.R") | |
biocLite("BSgenome.Mmusculus.UCSC.mm10") | |
setwd("~/BIO2/MBDseq_Mouse_Muscle_Tcell_JungHo") | |
library(BSgenome.Mmusculus.UCSC.mm10) | |
chrs <- names(Mmusculus)[1:21] | |
CGs <- lapply(chrs, function(x) start(matchPattern("CG", Mmusculus[[x]]))) |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
# index the genome | |
$ bwa index hs37d5.fa | |
# create a genome dictionary file | |
$ picard-tools CreateSequenceDictionary R=genome.fa O=genome.dict | |
# align reads using 'bwa mem' | |
$ls -1 *.gz | cut -d. -f1 | sort | uniq | while read l; do bwa mem -t 40 ~/00-NGS/Annotation/HipSci/hs37d5.fa $l.1.val.1.fq.gz $l.2.val.2.fq.gz > $l.PE.sam ; done & | |
# sam to bam |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
#################################################### | |
# # | |
# to report base composition at all mapped sites # | |
# # | |
#################################################### | |
# only when NM tag is missing in BAM | |
$ samtools calmd BAM ref.fasta | samtools view -b - -o BAM.NMtag.bam | |
# bam-readcount (use "-l" for regions of interest, "-w 0" for no warning) |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
library(ggplot2) | |
library(ggpmisc) | |
library(ggpubr) | |
library(ggrepel) | |
library(reshape2) | |
setwd("~/BIO2/DAM_ID/DamID_2018/SE/mm9") | |
setwd("~/BIO2/DAM_ID/RNAseq_shDnmt1/mm9") | |
te = "LINE.5kb" |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
if (!requireNamespace("BiocManager", quietly = TRUE)) | |
install.packages("BiocManager") | |
BiocManager::install("TCGAbiolinks") | |
library("AnnotationDbi") | |
library("DESeq2") | |
library("calibrate") | |
library("dplyr") | |
library("ggplot2") | |
library("ggpmisc") |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
BiocUpgrade() | |
source("http://bioconductor.org/biocLite.R") | |
biocLite(c("DESeq2","gplots","pcaExplorer","bovine.db","calibrate","AnnotationFuncs","gage","Rtsne","ggrepel")) | |
#library(TCGAbiolinks) | |
library(DESeq2) | |
library(pcaExplorer) | |
library(ggfortify) | |
library(ggplot2) | |
library(gplots) |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
#!/bin/bash | |
# Vatiants calling using 'bcftools mpileup - htslib' | |
export LC_ALL=C | |
printf "*** SNVcounter\n | |
*** 'samtools, bcftools, and bedtools' must be installed to run this script\n | |
*** Prepare 'reference fasta' and 'SNV list' in BED format\n | |
*** merge consecutive SNVs using\n | |
*** 'sort -k1,1 -k2,2n SNV.bed | mergeBed -c 4 -o collapse'\n |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
library(reshape2) | |
library(ggplot2) | |
library(ggpubr) | |
library(tidyverse) | |
library(gridExtra) | |
library(Biobase) | |
library(GEOquery) | |
library(limma) | |
library(matrixStats) |