お家でできるMacBookでやる次世代シーケンスデータ解析 pdf

Size: px
Start display at page:

Download "お家でできるMacBookでやる次世代シーケンスデータ解析 pdf"

Transcription

1 Mac Book

2 @n0rr 2012/03/ /03/30

3 R UNIX UNIX/ Linux Mac Book Pro Mac UNIX NGS SEQanswers Mac Book ii

4 1 UNIX bowtie

5 1 Bowtie UNIX Linux 1. Bowtie 2. Bowtie 3. Bowtie Mac Mac Book Pro Apple Store Lion Mac OS X GHz Intel nor mac Core i5 8G 1333MHz DDR3 Macintosh HD 13-inch HDD 320GB HDD 4 4

6 Dock ls Last login: Sat Jan 21 18:07:52 on ttys000 dhcp :~ nor$ ls Desktop Documents Downloads Library Movies Music Pictures Public R analtools dhcp :~ nor$ Finder [ ] [ ] [ ] [ ] [Pro] Last login: Sat Jan 21 18:07:52 on ttys000 dhcp :~ nor$ nor nor Mac Book Pro /Users nor ls -a 5

7 dhcp :~ nor$ ls -a....cfusertextencoding.ds_store.rdata.rapp.history -l dhcp :~ nor$ ls -l total 2944 drwx nor staff :16 Desktop drwx nor staff :53 Documents drwx nor staff :14 Downloads Bowtie analtools dhcp :~ nor$ mkdir analtools /Users/nor/ /Users/ nor/analtools Bowtie Bowtie bowtie-bio/files/bowtie/0.12.7/bowtie macos-10.5-x86 _64.zip/download sourceforge 7/ bowtie macos-10.5-x86_64.zip analtools cd analtools ls dhcp :~ nor$ cd analtools dhcp :analtools nor$ ls bowtie macos-10.5-x86_64.zip bowtie macos-10.5-x86_64.zip unzip dhcp :analtools nor$ unzip bowtie macos-10.5-x86_64.zip bowtie macos-10.5-x86_64.zip / Users/nor/analtools bowtie ls cd bowtie

8 dhcp :downloads nor$ cd bowtie dhcp :bowtie nor$ Bowtie make Bowtie dhcp :bowtie nor$ /Users/nor/analtools/bowtie /bowtie No index, query, or output file specified! Usage: bowtie [options]* <ebwt> {-1 <m1> -2 <m2> --12 <r> <s>} [<hit>] Bowtie tab /Users/nor/analtools/bowtie /reads dhcp :bowtie nor$ cd reads/ dhcp :reads nor$ ls e_coli_1000.fa e_coli_10000snp.fa e_coli_1000_1.fq e_coli_1000.fq e_coli_10000snp.fq e_coli_1000_2.fa e_coli_1000.raw e_coli_1000_1.fa e_coli_1000_2.fq Genome Analyzer Ⅱx fastq.fq e_coli_1000.fq more dhcp :reads nor$ more GAACGATACCCACCCAACTATCGCCATTCCAGCAT + CCGAACTGGATGTCTCATGGGATAAAAATCATCCG + TCAAAATTGTTATAGTATAACACTGTTGCTTTATG + EDCCCBAAAA@@@@?>===<;;9: more GAACGATACCCACCCAACTATCGCCATTCCAGCAT + EDCCCBAAAA@@@@?>===<;;9: ID + + ID 7

9 +ID more [control] [c] wc -l e_coli_1000.fq 1000 /Users/nor/analtools/bowtie /genomes fastq dhcp :reads nor$ more e_coli_1000.fq wc -l 4000 wc UNIX more e_coli_1000.fq wc dhcp :reads nor$ cd.. dhcp :bowtie nor$ cd genomes/ dhcp :genomes nor$ ls NC_ fna cd cd.. /Users/nor/analtools/bowtie /genome cd.. /Users/nor/analtools/bowtie / cd genomes/ /Users/nor/analtools/bowtie /genomes cd../genomes/ ls NC_ fna.fna fasta more wc 8

10 dhcp :genomes nor$ more NC_ fna >gi ref NC_ Escherichia coli 536, complete genome AGCTTTTCATTCTGACTGCAACGGGCAATATGTCTCTGTGTGGATTAAAAAAAGA GTGTCTGATAGCAGCTTCTGAACTGGTTACCTGCCGTGAGTAAATTAAAATTTTA TTGACTTAGGTCACTAAATACTTTAACCAATATAGGCATAGCGCACAGACAGATA AAAATTACAGAGTACACAACATCCATGAAACGCATTAGCACCACC dhcp :genomes nor$ more NC_ fna wc k bowtie dhcp :genomes nor$ /Users/nor/analtools/bowtie /bowtie-build NC_ fna NC_ bowtie-build bowtie-build Path NC_ fna NC_ Path ls cd wc /usr/bin/ Path bowtie-build Path /Users/nor/analtools/ bowtie / Path / use/bin install install Path dhcp :genomes nor$ PATH=$PATH:/Users/nor/analtools/bowtie / bowtiebuild ls dhcp :genomes nor$ ls NC_ ebwt NC_ ebwt NC_ rev.2.ebwt NC_ ebwt NC_ fna NC_ ebwt NC_ rev.1.ebwt dhcp :genomes nor$ /Users/nor/analtools/bowtie /bowtie -l 32 -n 2 --best -p 1 /Users/nor/analtools/bowtie /genomes/NC_ /Users/nor/analtools/bowtie /reads/e_coli_1000.fq more /Users/nor/ analtools/bowtie /bowtie bowtie Path bowtie -l 32 bowtie 32 -n 2 SNP 9

11 --best -p 1 4 Path Path bowtie more ID dhcp :genomes nor$ /Users/nor/analtools/bowtie /bowtie -l 32 -n 2 --best -p 1 /Users/nor/analtools/bowtie /genomes/NC_ /Users/nor/analtools/bowtie /reads/e_coli_1000.fq > bowtie_mapped_e_coli_1000_2_nc_ txt > bowtie_mapped_e_coli_1000_2_nc_ txt /Users/nor/analtools/bowtie /genomes /Users/nor/ Desktop dhcp :genomes nor$ /Users/nor/analtools/bowtie /bowtie -l 32 -n 2 --best -p 1 /Users/nor/analtools/bowtie /genomes/NC_ /Users/nor/analtools/bowtie /reads/e_coli_1000.fq > /Users/nor/Desktop/bowtie_mapped_e_coli_1000_2_NC_ txt # reads processed: 1000 # reads with at least one reported alignment: 697 (69.70%) # reads that failed to align: 303 (30.30%) Reported 697 alignments to 1 output stream(s) bowite analtools (ls, mkdir) 3. Bowtie analtools 10

12 4. analtools (cd) 5. Bowtie (unzip) 6. (ls, cd, more, wc) 7. (ls, cd, more, wc) 8. (bowtie-build) 9. (bowtie) 11

13 2 Bowtie Bowtie 1. Bowtie 2. DDBJ 3. DDBJ Sequence Read Archive [ ] DRASearch Kc167 mrna SRR DRASearch Accession SRR Search 12

14 SRR Kc167 Single Pair end ) Trizol Illumina GA 36bp SRR fastq.bz2 /Users/nor/Download/ Finder dhcp :~ nor$ mkdir drkc167 dhcp :~ nor$ cd drkc167 /Users/nor/ /Users/nor/drkc167/ drkc167 Finder FASTQ SRR fastq.bz2 FTP SRR fastq.bz2 DRASearch Study SRR fastq.bz2 /Users/nor/drkc167 dhcp :~ drkc167$ cp /Users/nor/Download/SRR fastq.bz2 /Users/nor/drkc167/SRR fastq.bz2 ls SRR fastq.bz2 /Users/ nor/drkc167/.fastq.bz2 bzip2 fastq 13

15 dhcp :drkc167 nor$ bzip2 -dc SRR fastq.bz2 > SRR fastq > fastq ls dhcp :drkc167 nor$ ls -l total rw-r--r-- 1 nor staff :36 SRR fastq -rw-r--r--@ 1 nor staff :34 SRR fastq.bz2 more fastq wc dhcp :drkc167 nor$ wc -l SRR fastq SRR fastq SRR fastq ID SRR HWI-EAS440_42_2_1_N_N / Ensemble cdna dhcp :drkc167 nor$ more HWI-EAS440_42_2_1_1600_2041 ACCGAAGCCATACGAGAGGCCCGCGGACTTCATCGA + HWI-EAS440_42_2_1_785_608 ACGAGTTCCAGAACTTGCACGCCGTTGCCAAGGAGA + HWI-EAS440_42_2_1_1408_814 ATAAAGTTCATGGCATTTGAAGAAAAACTGTGTTTA + IIIIII+IIIIIIIIIIIIII1IIIIIIIIIIIIII Drosophila melanogaster cdna [FASTA] FTP 14

16 genomic DNA [README] all ab initio README all cdna ab initio cdna all /Users/ nor/download/ / Users/nor/drkc167/ n0rr:drkc167 nor$ gunzip Drosophila_melanogaster.BDGP5.65.cdna.all.fa.gz n0rr:drkc167 nor$ /Users/nor/analtools/bowtie /bowtie -l 36 -n 2 -p 4 Drosophila_melanogaster.BDGP5.65.cdna.all SRR fastq > bowmapped_l36n2_srr txt /Users/nor/analtools/ bowtie /bowtie bowtie path bowtie -l 36 -n 2 -p 4 CPU > (bowmapped_l36n2_srr txt) bowtie more bowtie n0rr:drkc167 nor$ /Users/nor/analtools/bowtie /bowtie-build Drosophila_melanogaster.BDGP5.65.cdna.all.fa Drosophila_melanogaster.BDGP5.65.cdna.all 15

17 SRR HWI-EAS440_42_2_1_1326_1394 ID + FBtr AGCGCATCCGCGTCAAGCTCGACGGCTCCCAGCTGG IIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIII :G>C G C bowtie # reads processed: # reads with at least one reported alignment: (84.59%) # reads that failed to align: (15.41%) Reported alignments to 1 output stream(s) phix 98.5% 80% mrna 50-60% unix n0rr:drkc167 nor$ more bowmapped_l36n2_srr txt awk -F "\t" '{print $3}' sort uniq -c awk '{print $2"\t"$1}' > count_bowmapped_l36n2_srr txt 16

18 more [control] [c] awk awk unix -F \t \t {print } {print $3} sort uniq -c awk $1 $2 A, B, C n0rr:drkc167 nor$ more ABC.txt A B C A B A A B B C n0rr:drkc167 nor$ more ABC.txt sort uniq A B C n0rr:drkc167 nor$ more ABC.txt sort uniq -c 2 A 2 B 1 C awk n0rr:drkc167 nor$ more ABC.txt sort uniq -c awk '{print $2"\t"$1}' A 2 B 2 C 1 n0rr:drkc167 nor$ more ABC.txt sort more 17

19 cdna n0rr:drkc167 nor$ more count_bowmapped_l36n2_srr txt 1 FBtr FBtr FBtr FBtr FBtr FBtr FBtr wc cdna 1. (mkdir) (cp) 4. (bzip2 -dc) 5. (more, wc -l) (gunzip) 9. (bowtie-build) 10. (bowtie) n0rr:drkc167 nor$ more Drosophila_melanogaster.BDGP5.65.cdna.all.fa grep ">" wc -l /25415=74% 11. (more) 12. (more, awk, sort, uniq -c) mrna 18

20 3 bowtie cdna bowtie -n SNP Indel SNP Indel SNP Indel bowtie SNP Indel Indel bwa bwa 19

21 HapMap ID H_IJ-NA18973 DRA Experiment: Study: 6 Run: Run.fastq.bz2 HP DNA SRR077861_1.fastq.bz2 SRR077861_2.fastq.bz2 SRR fastq.bz2 DNA DNA cdna acc=erx /Users/nor/ dhcp :~ nor$ mkdir homo_snp_srr

22 bzip2 dc dhcp :~ homo_snp_srr077861$ bzip2 -dc SRR077861_1.fastq.bz2 > SRR07786_1.fastq dhcp :~ homo_snp_srr077861$ bzip2 -dc SRR077861_2.fastq.bz2 > SRR07786_2.fastq 13 ftp://genome-ftp.cse.ucsc.edu/goldenpath/hg19/bigzips/ chromfa.tar.gz dhcp :~ homo_snp_srr077861$ tar zxvf chromfa.tar.gz cat dhcp :~ homo_snp_srr077861$ cat *.fa > chr_all.fa.fa dhcp :~ homo_snp_srr nor $ mkdir reference dhcp :~ homo_snp_srr nor $ mv chr_all.fa./reference/chr_all.fa bwa bwa source forge /Users/nor/analtools/ /Users/nor/ analtools/ bwa / Users/nor/analtools/bwa/ bwa tar.bz2 n0rr:nakagawa nor$ cd /Users/nor/analtools/bwa/ n0rr:bwa nor$ tar zxvf bwa tar.bz2 /Users/nor/analtools/bwa/bwa-0.6.1/ n0rr:bwa nor$ cd bwa n0rr:bwa nor$ make 21

23 make bwa make install bwa /usr/bin/ path norr:bwa nor$ make -bash: make: command not found xcode Snow Leopard Lion xcode 3G sdk MacOSx10.5 n0rr:bwa nor$ /Users/nor/analtools/bwa/bwa-0.6.1/bwa Program: bwa (alignment via Burrows-Wheeler transformation) Version: r104 Contact: Heng Li Usage: bwa <command> [options] Command: index index sequences in the FASTA format aln gapped/ungapped alignment samse generate alignment (single ended) sampe generate alignment (paired ended) bwasw BWA-SW for long queries fastmap identify super-maximal exact matches fa2pac convert FASTA to PAC format pac2bwt generate BWT from PAC pac2bwtgen alternative algorithm for generating BWT bwtupdate update.bwt to the new format bwt2sa generate SA from BWT and Occ pac2cspac convert PAC to color-space PAC stdsw standard SW/NW alignment bwa bwa bowtie bwa path n0rr:bwa nor$ PATH=$PATH:/Users/nor/analtools/bwa/bwa-0.6.1/ bwa path bwa n0rr:bwa nor$ bwa 22

24 /Users/ nor/homo_snp_srr077861/reference /Users/nor/homo_SNP_SRR bwa dhcp :homo_snp_srr nor$ /Users/nor/analtools/bwa/bwa-0.5.9/bwa index -a bwtsw./reference/chr_all.fa./ reference/chr_all.fa reference chr_all.fa /Users/nor/homo_SNP_SRR077861/reference/chr_all.fa bwa dhcp :homo_snp_srr nor$ /Users/nor/analtools/bwa/bwa-0.5.9/bwa aln./reference/chr_all.fa SRR077861_1.fastq > aln_sa1.sai dhcp :homo_snp_srr nor$ /Users/nor/analtools/bwa/bwa-0.5.9/bwa aln./reference/chr_all.fa SRR077861_2.fastq > aln_sa2.sai dhcp :homo_snp_srr nor$ /Users/nor/analtools/bwa/bwa-0.5.9/bwa sampe./reference/chr_all.fa aln_sa1.sai aln_sa2.sai SRR077861_1.fastq SRR077861_2.fastq > bwa_aln.sam.sam Sequence Alignment/Map (SAM) samtools bowtie SAM -S samtools sourceforge samtools /Users/nor/analtools samtools samtools 23

25 dhcp :homo_snp_srr nor$ cd /Users/nor/analtools/ dhcp :analtools nor$ mkdir samtools dhcp :analtools nor$ cd samtools samtools tar.bz2 dhcp :analtools nor$ tar zxvf samtools samtools tar.bz2 samtools dhcp :analtools nor$ cd samtools samtools dhcp :analtools nor$ make samtools dhcp :homo_snp_srr nor$ /Users/nor/analtools/samtools/samtools /samtools view -b -o bwa_aln.sam.bam -S -t./reference/chr_all.fa.fai bwa_aln.sam sam samtools view bam bam more dhcp :homo_snp_srr nor$ /Users/nor/analtools/samtools/samtools /samtools sort bwa_aln.sam.bam bwa_aln.sam.bam.sorted bam dhcp :homo_snp_srr nor$ /Users/nor/analtools/samtools/samtools /samtools mpileup -uf./reference/chr_all.fa bwa_aln.sam.bam.sorted.bam /Users/nor/analtools/samtools/samtools /bcftools/bcftools view -bvcg - > bwa_aln.var.raw.bcf samtools mpileup -f bcf varfilter dhcp :homo_snp_srr nor$ /Users/nor/analtools/samtools/samtools /bcftools/bcftools view bwa_aln.var.raw.bcf /Users/nor/analtools/samtools/samtools /bcftools/vcfutils.pl varfilter -D 500> bwa_aln.var.vcf vcf vcf samtools HP 1. (bzip2 -dc/ tar zxvf) 2. (mv) 24

26 3. (make) 4. (bwa) 5. (samtools) 6. (samtools) Mac Book Air E. coli. ftp://ftp.ddbj.nig.ac.jp/ddbj_database/dra/fastq/sra008/s RA008271/SRX SRR fastq.bz2 Send File FASTA Create File sequence.fasta /Users/nor/ Downloas/ /Users/nor/otherPJ/macde/ ecoli otherpj $nor cd /Users/nor/ $nor mkdir otherpj $nor cd otherpj $nor mkdir macde $nor cd macde $nor mkdir ecoli $nor cd ecoli /Users/nor/Download/ (SRR fastq.bz2) 25

27 (sequence.fasta) Finder /Users/nor/otherPJ/macde/ ecoli/ mv nor$ mv /Users/nor/Downloads/SRR fastq.bz2././ nor$ mv /Users/nor/Downloads/sequence.fasta./ samtools fai nor$ /Users/nor/analtools/samtools/samtools /samtools faidx sequence.fasta bam bowtie nor$ /Users/nor/analtools/bowtie /bowtie-build sequence.fasta sequence nor$ bzip2 -cd SRR fastq.bz2 > SRR fastq nor$ /Users/nor/analtools/bowtie /bowtie -n 2 -l 36 -p 4 -S sequence SRR fastq > bowmap_srr sam nor$ /Users/nor/analtools/samtools/samtools /samtools view -b -o aln.sam.bam -S -t sequence.fasta.fai bowmap_srr sam sort nor$ /Users/nor/analtools/samtools/samtools /samtools sort aln.sam.bam aln.sam.bam.sorted nor$ /Users/nor/analtools/samtools/samtools /samtools mpileup -uf sequence.fasta aln.sam.bam.sorted.bam 26

28 /Users/nor/analtools/samtools/samtools /bcftools/bcft ools view -bvcg - > aln.var.raw.bcf varfilter nor$ /Users/nor/analtools/samtools/samtools /bcftools/bcft ools view aln.var.raw.bcf /Users/nor/analtools/samtools/samtools /bcftools/vcf utils.pl varfilter > aln.var.vcf aln.var.vcf PCR duplicate bam nor$ /Users/nor/analtools/samtools/samtools /samtools mpileup -uf sequence.fasta aln.uniq.bam /Users/nor/analtools/samtools/samtools /bcftools/bcft ools view -bvcg - > aln.uniq.var.raw.bcf varfilter $nor /Users/nor/analtools/samtools/samtools /bcftools/bcft ools view aln.uniq.var.raw.bcf /Users/nor/analtools/samtools/samtools /bcftools/vcf utils.pl varfilter > aln.uniq.var.vcf nor$ /Users/nor/analtools/samtools/samtools /samtools mpileup -f sequence.fasta aln.sam.bam.sorted.bam > aln.cov.txt PCR duplicate bam samtools rmdup PCR duplicate nor$ /Users/nor/analtools/samtools/samtools /samtools rmdup -s aln.sam.bam.sorted.bam aln.uniq.bam nor$ /Users/nor/analtools/samtools/samtools /samtools mpileup -f sequence.fasta aln.uniq.bam > aln.uniq.cov.txt 27

29 チャプタ 2 Rをつかって やるところ 発現変動遺伝子抽出 カバレッジの統計をとる

30 1 UNIX R R 1. R 2. R 3. R R /03/ R SRA RNA-seq 29

31 SRR001358, SRR bowtie cdna( ftp://ftp.ensembl.org/pub/release-66/fasta/mus_musculus/cdna/ Mus_musculus.NCBIM37.66.cdna.all.fa.gz) -S.sam awk -F "\t" '{print $3}' sort uniq -c /Users/nor/ / Users/nor/otherPJ/macde/ R join nor$ cat gene_counts_liver.txt gene_counts_skemuscle.txt awk '{print $2}' sort uniq > genename.txt $ more Mus_musculus.NCBIM37.66.cdna.all.fa grep ">" awk -F " " '{print $1}' tr -d ">" sort > genename.txt join $ more gene_counts_liver.txt awk {print $2 \t $1} > temp1 30

32 join sort sort tophat CASAVA sort more filename sort > filename2 nor$ more gene_counts_skemuscle.txt awk '{print $2"\t"$1}' > temp2 join nor$ join a 1 -a 1 genename.txt temp1 awk '{print $1"\t"$2+0}' more temp11 nor$ join a 1 -a 1 genename.txt temp1 awk '{print $1"\t"$2+0}' > temp11 nor$ join a 1 -a 1 genename.txt temp2 awk '{print $1"\t"$2+0}' > temp21 wc temp1 temp2 temp11 temp21 UNIX 31

33 paste awk temp3 nor$ paste temp11 temp21 awk '{print $1"\t"$2"\t"$4}' > temp3 $ vi header.txt vim i INSERT genename liver skmus [esc] [:][w][q] vim header.txt CR mi LF 32

34 temp3 nor$ cat header.txt temp3 > for_r_liv_vs_skm.txt R R data<-read.table("/users/nor/otherpj/macde/for_r_liv_vs_ skm.txt",header=t,row.names=1) data /Users/nor/otherPJ/macde/ 33

35 for_r_liv_vs_skm.txt data attach liver skelm summary liver skelm (Differentially Expressed Genes/ DEG) DESeq DEG DESeq HP source(" plot(log(liver),log(skelm),pch=20) bioclite("deseq", dependencies=true) DESeq DESeq (n=1) out_f <- "DESeq_out_liv_vs_skelm.txt" param1 <- 1 param2 <- 1 library(deseq) data.cl <- c(rep(1, param1), rep(2, param2)) cds <- newcountdataset(data, data.cl) 34

36 cds <- estimatesizefactors(cds) sizefactors(cds) cds <- estimatevariancefunctions(cds, method="blind") out <- nbinomtest(cds, 1, 2) logratio <- out$log2foldchange FDR <- out$padj rank_fdr <- rank(fdr, ties.method="min") tmp <- cbind(rownames(data), data, logratio, FDR, rank_fdr) write.table(tmp, out_f, sep="\t", append=f, quote=f, row.names=f) FDR DEG55 (FDR<0.05) DEG /Users/nor/ DESeq_out_liv_vs_skelm.txt FDR DEG FDR False Discovery Rate p 35

37 par(mfrow=c(1,2)) barplot(matrix(sort(liver/sum(liver)))) barplot(matrix(sort(skelm/sum(skelm))),ylim=c(0,1)) 36

38 2 genomic DNA kc167 DNA genomic DNA SRR DRA 1. maq maq maq user s manual Mapass2 Work Flow maq PATH maq easyrun pileup /Users/nor/analtools/maq-0.7.1/scripts/maq.pl easyrun./dmel_genome/no_space_dmg.fa srr fastq && cd easyrun && maq pileup ref.bfa all.map > all_pileup.txt R R awk '($1=="chr2L"){print $2"\t"$4}' all_pileup.txt > chr2l_pileup_r.txt && 37

39 awk '($1=="chr3L"){print $2"\t"$4}' all_pileup.txt > chr3l_pileup_r.txt && awk '($1=="chr2R"){print $2"\t"$4}' all_pileup.txt > chr2r_pileup_r.txt && awk '($1=="chr3R"){print $2"\t"$4}' all_pileup.txt > chr3r_pileup_r.txt && awk '($1=="chr4"){print $2"\t"$4}' all_pileup.txt > chr4_pileup_r.txt && awk '($1=="chrX"){print $2"\t"$4}' all_pileup.txt > chrx_pileup_r.txt && awk '($1=="chrMT"){print $2"\t"$4}' all_pileup.txt > chrmt_pileup_r.txt R chr3r_pileup_r.txt R pos count plot(pos,count,pch=20,col=ifelse(count < 1, "red", "black")) 38

40 0rate 0 13 vs 10 chr3l kc167 MT chr length Zero 0rate Cov. Max chr3l chrx chrmt chr2l chr2r chr3r chr small RNA 39

41 チャプタ 3 その他の問題 と対処 bcl変換とデマルチプレックス クオリティチェック コントロール 記憶媒体のフォーマット

42 1 bcl illumina Genome Analyzer Ⅱx bcl stats fastq CASAVA fastq 1. CASAVA illumina Genome Analyzer Ⅱx fastq 2. fastq UNIX bash 3. bash bcl Illumina CASAVA CASAVA illumina CASAVA v1.8.0 $ tar -jxf CASAVA_v1.8.0.tar.bz2 $ mkdir CASAVA_v1.8.0-build $ cd CASAVA_v1.8.0-build $../CASAVA_v1.8.0/configure $ make $ make install CASAVA_v1.8.0.tar.bz2 / Users/nor/analtools/ /analtools make install 41

43 bcl Genome Analyzer _HWUSI- EAS1748_00049_FC CASAVA HDD bcl HDD fastq fastq.gz 70bp 10GB fastq 100GB HDD LOGITEC_HD test /Volumes/LOGITEC_HD/test/120114_HWUSI- EAS1748_00049_FC/ SSD NOGEBLANC /Volumes/NOGEBLANC/ _5 nor$ configurebcltofastq.pl --input-dir /Volumes/LOGITEC_HD/test/120114_HWUSI-EAS1748_00049_FC/Data/Inten sities/basecalls/ --output-dir /Volumes/NOGEBLANC/120114_5 --use-bases-mask y72 --use-bases-mask y72 65bp( )+7bp( ) [ :09:49] [configurebcltofastq.pl] INFO: Creating directory '/Volumes/NOGEBLANC/120114_5' [ :09:49] [configurebcltofastq.pl] INFO: Basecalling software: RTA [ :09:49] [configurebcltofastq.pl] INFO: version: 1.09 (build 35) [ :09:49] [configurebcltofastq.pl] WARNING: 'LocationFileType' element not found in /Volumes/LOGITEC_HD/test/120114_HWUSI-EAS1748_00049_FC/Data/Intensities/BaseCalls/../RTAConfiguration.xml [ :09:49] [configurebcltofastq.pl] INFO: Original use-bases mask: y72 [ :09:49] [configurebcltofastq.pl] INFO: Guessed use-bases mask: yyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyy,iiiiiin Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane1' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane2' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane3' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane4' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane5' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane6' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane7' Creating directory '/Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane8' [ :09:50] [configurebcltofastq.pl] WARNING: Couldn't determine control software version due to missing /Volumes/LOGITEC_HD/test/120114_HWUSI-EAS1748_00049_FC/Data/Intensities/BaseCalls/../../../runParameters.x ml [ :09:50] [configurebcltofastq.pl] WARNING: use-base-mask length is 72 for read 1: expected length from config file is 65 [ :09:50] [configurebcltofastq.pl] INFO: Read 1: length = 72: mask = yyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyyy 42

44 [ :09:50] [configurebcltofastq.pl] WARNING: Read 2: current cycle in mask is 73: first cycle in read is 66 [ :09:50] [configurebcltofastq.pl] INFO: Read 2: length = 7: mask = IIIIIIn [ :09:50] [configurebcltofastq.pl] WARNING: use-base-mask length is 72 for read 1: expected length from config file is 65 [ :09:50] [configurebcltofastq.pl] WARNING: Read 2: current cycle in mask is 73: first cycle in read is 66 [ :09:50] [configurebcltofastq.pl] INFO: Running self tests: 'make self_test' [ :09:53] [configurebcltofastq.pl] INFO: Running self tests on /Volumes/NOGEBLANC/120114_5 completed with no problems /Volumes/NOGEBLANC/120114_5 make n0rr:120114_4 nor$ cd /Volumes/NOGEBLANC/120114_5/ n0rr:120114_5 nor$ nohup make -j 2 nohup.out configurebcltofastq.pl (Basecalls bcl /Volumes/NOGEBLANC/120114_5 fastq.gz dhcp :120114_5 nor$ cd /Volumes/NOGEBLANC/120114_5/Project_FC/ Sample_lane1/ dhcp :sample_lane1 nor$ gunzip lane1_noindex_l001_r1_001.fastq.gz more wc fastq nor$ more lane1_noindex_l001_r1_001.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/ K@HWUSI/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' > line_lane1.fastq.txt nor$ more line_lane1.fastq.txt grep "ATCACG$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_1_1_index1_atcacg.fastq 43

45 tr 3. [sed -e K tr A B A B sed awk 4. [tr K \n ] K grep more more fasq 1. [tr " " "_ ] 5. [awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}'] + 2. [tr \n \t ] 6. [> line_lane1.fastq.txt] 44

46 fastq grep grep "ATCACG$" ATCACG $ fastq fastq fastq.gz bash.sh chmod sh # $1: lane number. so 1 or 2 or 3 or 4 or 5 or 6 or 7 or 8 # This command lines are prepared for 65 bp single reads. If you want to use them for other length reads, modify the number of "substr" region. 65->N and 66->N+1. # Skip the unsupporting index separating greps. Use "#" to inactivation. #making fastq 2 linefastq, separating index reads, and assembling them. more lane"$1"_noindex_l00"$1"_r1_001.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' > line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_002.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_003.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_004.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_005.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_006.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_007.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_008.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && more lane"$1"_noindex_l00"$1"_r1_009.fastq tr " " "_" tr "\n" "\t" sed -e 's/@hwusi/k@hwusi/g' tr "K" "\n" awk -F "\t" '{print $1"\t"substr($2,1,65)"\t+\t"substr($4,1,65)"\t"substr($2,66,6)}' >> line_lane"$1".fastq.txt && 45

47 echo "fastq2linefastq" more line_lane"$1".fastq.txt grep "TAGCTT$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index10_tagctt.fastq && #making fastq by an index. #Index1 more line_lane"$1".fastq.txt grep "ATCACG$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index1_atcacg.fastq && #Index2 #index11 more line_lane"$1".fastq.txt grep "GGCTAC$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index11_ggctac.fastq && #Index12 more line_lane"$1".fastq.txt grep "CTTGTA$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index12_cttgta.fastq && more line_lane"$1".fastq.txt grep "CGATGT$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index2_cgatgt.fastq && #Index3 more line_lane"$1".fastq.txt grep "TTAGGC$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index3_ttaggc.fastq && echo "finish (^o^)b" #Index4 more line_lane"$1".fastq.txt grep "TGACCA$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index4_tgacca.fastq && #Index5 more line_lane"$1".fastq.txt grep "ACAGTG$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index5_acagtg.fastq && #Index6 more line_lane"$1".fastq.txt grep "GCCAAT$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index6_gccaat.fastq && #index7 more line_lane"$1".fastq.txt grep "CAGATC$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index7_cagatc.fastq && #index8 more line_lane"$1".fastq.txt grep "ACTTGA$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index8_acttga.fastq && #index9 more line_lane"$1".fastq.txt grep "GATCAG$" awk '{print $1"\n"$2"\n"$3"\n"$4}' > s_"$1"_1_index9_gatcag.fastq && #index10 split_index_for_mac_unix.sh /Volumes/NOGEBLANC/120114_5/ Project_FC/Sample_lane1/ lane1_noindex_l001_r1_001.fastq, lane1_noindex_l001_r1_002.fastq, lane1_noindex_l001_r1_003.fastq, lane1_noindex_l001_r1_004.fastq /Volumes/NOGEBLANC/ _5/Project_FC/Sample_lane1/ split_index_for_mac_unix.sh 46

48 nor$ cd /Volumes/NOGEBLANC/120114_5/Project_FC/Sample_lane1/ nor$ chmod 777 split_index_for_mac_unix.sh nor$ sh split_index_for_mac_unix.sh 1 $1 # Index 1-12 grep # 47

49 2 fastq Illumina Genome Analyzer Ⅱx HiSeq 1. FastQC FastQC FastQC [Download Now] [FastQC v (Mac DMG image)] Finder 48

50 FastQC [ ] [File] [Open] /Users/nor/ drkc167/ fastq [File] [Save report] zip html zip html 11 Basic Statistics Per base sequence quality Per sequence quality scores Per base sequence content Per base GC content Per sequence GC content 49

51 Per base N content Sequence Length Distribution Sequence Duplication Levels Per base sequence content Overrepresented sequences Kmer Content Basic Statistics Per base GC content GC Per sequence GC content GC AT Per base sequence quality AT GC HiSeq Per base N content N Per sequence quality scores Sequence Length Distribution 50

52 cut adapt Sequence Duplication Levels GenomeJack Sequence Duplication Levels PCR PCR RNA-seq Overrepresented sequences Kmer Content Kmer Kmer 5 GenomeJack bioinformatics/solution/products/genomejack/index.html (@genomejack ) PC 51

53 PCR FastQC 90% PCR Duplication Levels PCR Duplication Levels RNAseq samtools rmdup PCR Duplication $ /Users/nor/analtools/samtools/samtools /samtools faidx /Users/nor/silk/reference/silkcds.fa $ /Users/nor/analtools/samtools/samtools /samtools view -b -o bowmap_silkcds_s_3_index6.sam.bam -t /Users/nor/silk/reference/silkcds.fa.fai bowmap_silkcds_s_3_index6.sam $ /Users/nor/analtools/samtools/samtools /samtools sort bowmap_silkcds_s_3_index6.sam.bam bowmap_silkcds_s_3_index6.sam.sorted $ /Users/nor/analtools/samtools/samtools /samtools rmdup -s bowmap_silkcds_s_3_index6.sam.sorted.bam bowmap_silkcds_s_3_index6.uniq.bam $ /Users/nor/analtools/samtools/samtools /samtools view bowmap_silkcds_s_3_index6.uniq.bam grep HWUSI awk '{print $3}' uniq -c awk '{print $2"\t"$1}' > count_bowmap_silkcds_s_3_index6.uniq.txt SNP sort bam 13349, 12867, 8852, 12734, 10790, 6436, 11927, 10808, 9335, 7642, 11210, 12074, 9257, cdna cdna De novo 52

54 cdna rmdup RNA-seq PCR duplication RNA cdna PCR duplication 53

55 3 GB GB 100GB ( FASTQ ) HDD SSD 1. OS 2. 4G 3. FAT32 NTS- F Mac OS FAT32 windows PC HDD USB FAT32 OS windows PC mac 4GB GB NTSF windows PC mac snow leopard Linux windows PC windows PC mac NTFS 54

56 NTFS_Enabler.txt.zip NTSF Mac OS mac B Time machine HDD UI split bcl bcl FASTQ 4GB 4GB FAT32 FAT32 FAT32 55

57 56

58 チャプタ 4 解析例 De novo アセンブリ シーケンスに失敗したphiXの評価

59 1 De novo transcriptome velvet n0rr:~ nor$ cd /Users/nor/analtools/ n0rr:analtools nor$ mkdir velvet 1. velvet mrna-seq velvet velvet_ tgz /Users/nor/analtools/velvet velvet_ tgz /users/nor/downloads velvet velvet_ tgz n0rr:analtools nor$ cd velvet n0rr:velvet nor$ ls velvet_ tgz n0rr:velvet nor$ tar zxvf velvet_ tgz velvet_ n0rr:velvet nor$ ls velvet_ velvet_ tgz 58

60 velvet_ n0rr:velvet nor$ cd velvet_ n0rr:velvet_ nor$ make MAXKMERLENGTH=63 MAXKMER- LENGTH=63 kmer n0rr:velvet_ nor$ /Users/nor/analtools/velvet/velvet_1.2.03/velveth velveth oases velvet oases /Users/nor/analtools oases oases_ tgz oases n0rr:velvet_ nor$ cd.. n0rr:velvet nor$ cd.. n0rr:analtools nor$ mkdir oases n0rr:analtools nor$ cd oases/ n0rr:oases nor$ mv /Users/nor/Downloads/oases_ tgz./oases_ tgz Finder n0rr:oases nor$ tar zxvf oases_ tgz n0rr:oases nor$ cd oases_ oases_ n0rr:oases_ nor$ make 'VELVET_DIR=/Users/nor/analtools/velvet/velvet_1.2.03/' 'MAXKMERLENGTH=63' velvet kmer n0rr: run_sample_lane3 nor$ /Users/nor/analtools/velvet/velvet_1.2.03/velveth./mac_velvet fastq s_3_1_sequence.txt n0rr: run_sample_lane3 nor$ cd mac_velvet63/ 59

61 n0rr:mac_velvet63 nor$ /Users/nor/analtools/velvet/velvet_1.2.03/velvetg./ -read_trkg yes -scaffolding no oases oases mrna-seq transcripts.fa n0rr:mac_velvet63 nor$ /Users/nor/analtools/oases/oases_0.2.05/oases./ nor$ more contigs.fa sed -e tr -d "\n" tr ">" "\n" awk -F '{print length($2)}' head -n4 head -n 4 nor$ head -n 4 contigs.fa contigs.fa transcripts.fa cdna n cdna nor$ more contigs.fa grep ">" wc -l > \n 1176 length_ kmer awk length contig length_63 nor$ grep length_62_ contigs.fa 60

62 62 63 contig CTGCAGCAGTTAAACCAAAAGCCTCGGCAAAAGCTCCAGGA AAA" wc nor$ more contigs.fa sed -e tr -d "\n" tr ">" "\n" grep _length_63_ awk -F '{print length($2)}' head -n4 nor$ more contigs.fa sed -e tr -d "\n" tr ">" "\n" grep _length_63_ awk -F '{print ">"$1"\n"$2}' head -n4 R nor$ more contigs.fa sed -e '/>/s/$/@/g' tr -d "\n" tr ">" "\n" awk -F "@" '{print length($2)}' tr "\n" "," > length_contigs.txt echo nor$ more transcripts.fa sed -e '/>/s/$/@/g' tr -d "\n" tr ">" "\n" awk -F "@" '{print length($2)}' tr "\n" "," > length_transcripts.txt nor$ more contigs.fa sed -e '/>/s/$/@/g' tr -d "\n" tr ">" "\n" grep _length_63_ awk -F "@" '{print ">"$1"\n"$2}' head -n4 nor$ echo "CTGCAGCAGTTAAACCAAAAGCCTCGGCAAAAGCTCCAGG AAAAGGTGTTAAGAAACCAACAGCAAAGGTGCTGCGAAAC 0,1176,1372,... lcon<c 0 61

63 R, ) lcon<-c(1176,1372,1125,2877,205,...,125,125) summary(lcon) R 62

64 hist(lcon) hist(log(lcon)) contigs.fa transcripts.fa transcipts.fa length_transcripts.txt MASS library(mass) truehist(log(lcon)) 63

65 2 phix Illumina Genome Analyzer Ⅱx Illumina Genome Analyzer Ⅱx FastQC 3. phix phix phix phix FastQC 4. 64

66 phix bowtie phix (-l 65 -n 2) 92.96% SEQanswers 98.5% phix "For comparison PhiX maps at around 98.5% which suggests that the reduction in human is due to genome complexity and not sequence quality." hlight=phix+sequence fastq fasta %, 5 TAAAAAACGTTCNGGCGGTCGCCCTGGTCGTC TGTCTAAAGGTAAAAAACGTTCTGGCGCTCGCCCTGGTCGTCCGCAGCCG ATTTCTAAAGGTAAAAAACGTGCTGGCGCTCG GAGTGATGTAATGTCTAAAGGTAAAAAACGTTCTGGCGCTCGCCCTGGTC ATTTCTACTCTTTCTNAATCCCCAATGCTTTG GGCTTGTGGCATTTCTACTCTTTCTCAATCCCCAATGCTTGGCTTCCATA TCTTGGACGNTTTTTTATGGTTCGTTCTTATT TGCCTCCAAATCTTGGAGGCTTTTTTATGGTTCGTTCTTATTACCCTTCT AATGTCACGNTGATTATTTTGACTTTGAGCCT TACCCTTCTGAATGTCACGCTGATTATTTTGACTTTGAGCGTATCGAGGC phix 0%(0 65

67 FastQC phix 0% poly-a # # FastQC 66

AJACS18_ ppt

AJACS18_ ppt 1, 1, 1, 1, 1, 1,2, 1,2, 1 1 DDBJ 2 AJACS3 2010 6 414:20-15:20 2231 DDBJ DDBJ DDBJ DDBJ NCBI (GenBank) DDBJ EBI (EMBL-Bank) GEO DDBJ Omics ARchive(DOR) ArrayExpress DTA (DDBJ Trace Archive) DRA (DDBJ

More information

シーケンサー利用技術講習会 第10回 サンプルQC、RNAseqライブラリー作製/データ解析実習講習会

シーケンサー利用技術講習会 第10回 サンプルQC、RNAseqライブラリー作製/データ解析実習講習会 シーケンサー利用技術講習会 第 10 回サンプル QC RNAseq ライブ ラリー作製 / データ解析実習講習会 理化学研究所ライフサイエンス技術基盤研究センターゲノムネットワーク解析支援施設田上道平 次世代シーケンサー Sequencer File Format Output(Max) Read length Illumina Hiseq2500 Fastq 600 Gb 100 bp Life

More information

PowerPoint プレゼンテーション

PowerPoint プレゼンテーション バイオインフォマティクス 講習会 V 事前準備 が完了されている方は コンテナの起動 ファイルのコピー (Windows) まで 進めておいてください メニュー 1. 環境構築の確認 2. 基本的なLinuxコマンド 3. ツールのインストール 4. NGSデータの基礎知識と前処理 5. トランスクリプトのアッセンブル 6. RNA-seqのリファレンスcDNAマッピングとFPKM 算出 7. RNA-seqのリファレンスゲノムマッピングとFPKM

More information

PowerPoint プレゼンテーション

PowerPoint プレゼンテーション V1 次世代シークエンサ実習 II 本講義にあたって 代表的な解析の流れを紹介します 論文でよく使用されているツールを使用します コマンドを沢山実行します スペルミスが心配な方は コマンド例がありますのでコピーして実行してください /home/admin1409/amelieff/ngs/reseq_command.txt マークのコマンドは実行してください 実行が遅れてもあせらずに 応用や課題の間に追い付いてください

More information

V1 ゲノム R e s e q 変異解析 Copyright Amelieff Corporation All Rights Reserved.

V1 ゲノム R e s e q 変異解析 Copyright Amelieff Corporation All Rights Reserved. V1 ゲノム R e s e q 変異解析 本講義にあたって 代表的な解析の流れを紹介します 論文でよく使用されているツールを使用します コマンドを沢山実行します スペルミスが心配な方は コマンド例がありますのでコピーし て実行してください マークのコマンドは実行してください 実行が遅れてもあせらずに 応用や課題の間に追い付いてくだ さい 2 本講義の内容 Reseq解析 RNA-seq解析 公開データ取得

More information

PowerPoint プレゼンテーション

PowerPoint プレゼンテーション V1 次世代シークエンサ実習 II 本講義の内容 Reseq 解析 RNA-seq 解析 公開データ取得 クオリティコントロール マッピング 変異検出 公開データ取得 クオリティコントロール マッピング 発現定量 FPKM を算出します 2 R N A - s e q とは メッセンジャー RNA(mRNA) をキャプチャして次世代シーケンサーでシーケンシングする手法 リファレンスがある生物種の場合

More information

バクテリアゲノム解析

バクテリアゲノム解析 GCCGTAGCTACCTTTACAATA GCCGTAGCT AGCTACC GCTACCTTT CCTTTAC CTTTACAATA GCCG CCGT CGTA GTAG TAGC AGCT AGCT GCTA CTAC TACC GCTA CTAC TACC ACCT CCTT CTTT CCTT CTTT TTTA TTAC CTTT TTTA TTAC TACA ACAA CAAT AATA

More information

Maeda140303

Maeda140303 2014 NGS NIBB - - - - FASTA / FASTQ - BED GFF/GTF WIG - SAM / BAM - SAMtools Web HTML (PC/), OS (Windows/Mac), IE/Chrome/Safari NGS Wet - - NGS - FASTA, FASTQ, csfastq, FASTA/qual, SRA, - BED, GFF/GTF,

More information

syspro-0405.ppt

syspro-0405.ppt 3 4, 5 1 UNIX csh 2.1 bash X Window 2 grep l POSIX * more POSIX 3 UNIX. 4 first.sh #!bin/sh #first.sh #This file looks through all the files in the current #directory for the string yamada, and then prints

More information

プレゼンテーション2.ppt

プレゼンテーション2.ppt ryamasi@hgc.jp BLAST Genome browser InterProScan PSORT DBTSS Seqlogo JASPAR Melina II Panther Babelomics +@ >cdna_test CCCCTGCCCTCAACAAGATGTTTTGCCAACTGGCCAAGACCTGCCCTGTGCAGCTGTGGGTTGATTCCAC ACCCCCGCCCGGCACCCGCGTCCGCGCCATGGCCATCTACAAGCAGTCACAGCACATGACGGAGGTTGTG

More information

1 I EViews View Proc Freeze

1 I EViews View Proc Freeze EViews 2017 9 6 1 I EViews 4 1 5 2 10 3 13 4 16 4.1 View.......................................... 17 4.2 Proc.......................................... 22 4.3 Freeze & Name....................................

More information

UNIX

UNIX 2000 1 UNIX 2000 4 14 1 UNIX? 2 1.1 UNIX OS....................................... 2 1.2.................................................... 2 1.3 UNIX...................................... 2 1.4 Windows

More information

unix.dvi

unix.dvi 1 UNIX 1999 4 27 1 UNIX? 2 1.1 Windows/Macintosh? : : : : : : : : : : : : : : : : : : : : : : : : 2 1.2 UNIX OS : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : 2 1.3 : : : : : : : : : : : :

More information

nagasaki_GMT2015_key09

nagasaki_GMT2015_key09 Workflow Variant Calling 03 長崎は遺伝研 大量遺伝情報研究室の所属です 国立遺伝学研究所 生命情報研究センター 3F 2F 欧州EBIと米国NCBIと密接に協力しながら DDBJ/EMBL/GenBank国際塩基配列データ ベースを構築しています 私たちは 塩基配列登録を支援するシステムづくり 登録データを活用するシステムづくり 高速シーケンス配列の情報解析 を行なっています

More information

141025mishima

141025mishima NGS (RNAseq) »NGS Now Generation Sequencer»NGS»» 4 NGS(Next Generation Sequencer) Now Generation Sequencer http://www.youtube.com/watch?v=womkfikwlxm http://www.youtube.com/watch?v=mxkya9xcvbq http://www.youtube.com/watch?v=nhcj8ptycfc

More information

名称未設定

名称未設定 Parallels Desktop 6 for Mac Read Me Parallels Desktop for Mac build 6.0.11822 Parallels Desktop for Mac 1.Parallels Desktop for Mac 2. 3. 4. 5. Parallels Desktop 6. Parallels Desktop 6 for Mac 7. Parallels

More information

<4D F736F F F696E74202D D D E C815B836A F B83582E >

<4D F736F F F696E74202D D D E C815B836A F B83582E > 2012.03.22 マッピングデータの基本フォーマットと基本ツール 次世代シーケンサーに良く用いられるファイル形式 Samtools Integrative Genomics Viewer(IGV) 基礎生物学研究所 生物機能解析センター 山口勝司 NIBB CORE RESEARCH FACILITIES FUNCTIONAL GENOMICS FACILITY NIBB CORE RESEARCH

More information

tebiki00.dvi

tebiki00.dvi (Linux) [ UNIX ] CMD Workshop ( ) 1 *********************************************************************** * Linux PC-UNIX UNIX * * 99% FreeBSD BSD PC-UNIX * * * ***********************************************************************

More information

Unix * 3 PC 2 Linux, Mac *4 Windows Cygwin Cygwin gnuplot Cygwin unix emulator online gnuplot *5 matplotlib *6 SuperMongo *7 gnuplot gnuplot OS *8 Uni

Unix * 3 PC 2 Linux, Mac *4 Windows Cygwin Cygwin gnuplot Cygwin unix emulator online gnuplot *5 matplotlib *6 SuperMongo *7 gnuplot gnuplot OS *8 Uni 2015 8 1 ( ) Unix 1 *1 Unix Unix Unix Perl, Python *2 Unix 2 PC gnuplot *1 100 10 10 6 10 = 10 7 1 1/3 3 10 7 10 7.5 1 24 3600 = (30 6)(30 + 6) 100 = 86400 1 10 7.5 *2 Perl, Python Python 1 Unix * 3 PC

More information

名称未設定

名称未設定 Parallels Desktop 4.0 for Mac ( 4.0.3810 ) Read Me : 1. Parallels Desktop 2. 3. 4. 5. 6. Parallels Desktop 7. Parallels Desktop 4.0 for Mac 8. Parallels Desktop 9. Parallels Desktop 10. 11. 12. 1. Parallels

More information

A

A A 3 2017 4 24 1 1 1.1.......................................... 1 1.2................................ 1 1.2.1................................ 1 1.2.2............................. 1 1.2.3................................

More information

untitled

untitled osamu@sfc.keio.ac.jp OK CNS OS CPU HDD FDD USB 1 (CPU) (CPU) CISCPentium4(Windows PC) RISCPowerPC(Macintosh PC) CPU CPU CPU CPU CD/DVD OS 2 OS Windows MacOS ( Talk, MacOSX) UNIX Word/Excel/PowerPoint etc..

More information

-2 gnuplot( ) j ( ) gnuplot /shell/myscript 1

-2 gnuplot( ) j ( ) gnuplot /shell/myscript 1 -2 gnuplot( ) j 2006 05 03 2006 05 12 2006 05 09 2 ( ) gnuplot /shell/myscript 1 1 shell script Level 1 myls #!/bin/sh # nowdir= pwd # if [ -f $1 -o -z $1 ] ; then echo "Enter pass" echo "ex) myls.sh./"

More information

Slide 1

Slide 1 イルミナテクニカルセミナー session3 Illumina Experiment Manager の使い方 サービス サポート部テクニカルサポートサイエンティスト渡辺真子 2011 Illumina, Inc. All rights reserved. Illumina, illuminadx, BeadArray, BeadXpress, cbot, CSPro, DASL, Eco, Genetic

More information

slice00_install.dvi

slice00_install.dvi Slice Installation manual SPring-8 1 Slice 1 1.1 Windows... 1 1.1.1 Cygwin... 1 1.2 MacOSX... 10 1.2.1 Xcode... 10 2 Slice 14 2.1 Slice... 14 1 1 Slice Slice Winsows UNIX (Liunx, FreeBSD, MacOSX ) Slice

More information

講義内容 ファイル形式 データの可視化 データのクオリティチェック マッピング アセンブル 資料の見方 $ pwd 実際に入力するコマンドを黄色い四角の中に示します 2

講義内容 ファイル形式 データの可視化 データのクオリティチェック マッピング アセンブル 資料の見方 $ pwd 実際に入力するコマンドを黄色い四角の中に示します 2 N G S 解析基礎 講義内容 ファイル形式 データの可視化 データのクオリティチェック マッピング アセンブル 資料の見方 $ pwd 実際に入力するコマンドを黄色い四角の中に示します 2 ファイル形式 NGS 解析でよく使われるファイル形式 ファイル形式 fastq bam/sam vcf bed fasta サンプルデータの場所 /home/ ユーザ名 /Desktop/amelieff/1K_ERR038793_1.fastq

More information

Introduction Purpose This training course describes the configuration and session features of the High-performance Embedded Workshop (HEW), a key tool

Introduction Purpose This training course describes the configuration and session features of the High-performance Embedded Workshop (HEW), a key tool Introduction Purpose This training course describes the configuration and session features of the High-performance Embedded Workshop (HEW), a key tool for developing software for embedded systems that

More information

Step 1 Feature Extraction Featuer Extraction Feature Extraction Featuer Extraction Image Analysis Start>Programs>Agilent-Life Sciences>Feature Extract

Step 1 Feature Extraction Featuer Extraction Feature Extraction Featuer Extraction Image Analysis Start>Programs>Agilent-Life Sciences>Feature Extract Agilent G2565AA Feature Extraction Step 1 Feature Extraction Step 2 Step 3 Step 4 ( ) Step 5 ( ) Step 6 Step 7 Step 8 Feature Extraction Step 9 Step 10 Feature Extraction Step 11 Feature Extraction Step

More information

4 2018 5 1 1 1 1.1.............................. 1 1.1.1....................... 1 1.1.2.................... 1 1.2...................... 1 1.2.1........................... 1 1.2.2............................

More information

[user@linux tmp]$ tar xzvf utvpn-src-unix-v100-7092-beta-2010.06.25.tar.gz [user@linux tmp]$ cd utvpn-unix-v100-7092-beta [user@linux utvpn-unix-v100-7092-beta]$ ls License-ja.txt configure makefiles src

More information

RT-PCR プロトコール.PDF

RT-PCR プロトコール.PDF Real -Time RT-PCR icycler iq Bio Rad RT-PCR RT-PCR 1 icycler iq Bio Rad icycler iq 30 2 Ready-To-Go T-Primed First-Strand Kit (amersham pharmacia biotech) Ready-To-Go T-Primed First-Strand Kit QuantiTect

More information

スパコンに通じる並列プログラミングの基礎

スパコンに通じる並列プログラミングの基礎 2018.09.10 furihata@cmc.osaka-u.ac.jp ( ) 2018.09.10 1 / 59 furihata@cmc.osaka-u.ac.jp ( ) 2018.09.10 2 / 59 Windows, Mac Unix 0444-J furihata@cmc.osaka-u.ac.jp ( ) 2018.09.10 3 / 59 Part I Unix GUI CUI:

More information

UnixText2.pptx

UnixText2.pptx Unix Unix! grep! sed! sort! cut! join! awk! (grep)! grep ' ' [...]! grep 'GO' 1433B_HUMAN.sprot!! 1433B_HUMAN.sprot GO grep '^FT' 1433B_HUMAN.sprot!! 1433B_HUMAN.sprot FT! grep -v! grep -i! grep -w!!!

More information

C1-202 / F-101 originally from 2014 4 15 3 1 3 C1 2 C1-202 F 1 F-101 PC imac MacPro OS Mac OS X C WWW L A TEX 2 3 4 e-mail kyama@tut.jp C-506 6767 5 2 2.1 ID ID 2.2 2.3 2.4 2.4.1 1. imac MacPro 2. 3.

More information

スパコンに通じる並列プログラミングの基礎

スパコンに通じる並列プログラミングの基礎 2018.06.04 2018.06.04 1 / 62 2018.06.04 2 / 62 Windows, Mac Unix 0444-J 2018.06.04 3 / 62 Part I Unix GUI CUI: Unix, Windows, Mac OS Part II 2018.06.04 4 / 62 0444-J ( : ) 6 4 ( ) 6 5 * 6 19 SX-ACE * 6

More information

UNIX

UNIX 2000 2 UNIX 2000 4 24 1 3 1.1 : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : 3 1.2 : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : : :

More information

¥¤¥ó¥¿¡¼¥Í¥Ã¥È·×¬¤È¥Ç¡¼¥¿²òÀÏ Âè11²ó

¥¤¥ó¥¿¡¼¥Í¥Ã¥È·×¬¤È¥Ç¡¼¥¿²òÀÏ Âè11²ó 11 2013 6 19 11 (6/19) 6 (18:10-19:40) λ13 UNIX : 2 / 26 UNIX UNIX sort, head, tail, cat, cut diff, tee, grep, uniq, wc join, find, sed, awk, screen 3 / 26 sort sort : $ sort [options] [FILE...] options

More information

2016_RNAseq解析_修正版

2016_RNAseq解析_修正版 平成 28 年度 NGS ハンズオン講習会 RNA-seq 解析 2016 年 7 27 本講義にあたって n 代表的な解析の流れを紹介します 論 でよく使 されているツールを使 します n コマンドを沢 実 します タイプミスが 配な は コマンド例がありますのでコピーして実 してください 実 が遅れてもあせらずに 課題や休憩の間に追い付いてください Amelieff Corporation All

More information

E2 Spider 2018/08/03 Intel NUC Core i7 PC 2.5 /M.2 SSD BOXNUC7I7BNH PC DDR4-2133(PC ) 8GBX2 260pin 1.2V CL15 SP016GBSFU213B22 WD SSD M /51

E2 Spider 2018/08/03 Intel NUC Core i7 PC 2.5 /M.2 SSD BOXNUC7I7BNH PC DDR4-2133(PC ) 8GBX2 260pin 1.2V CL15 SP016GBSFU213B22 WD SSD M /51 E2 Spider 2018/08/03 Intel NUC Core i7 PC 2.5 /M.2 SSD BOXNUC7I7BNH PC DDR4-2133(PC4-17000) 8GBX2 260pin 1.2V CL15 SP016GBSFU213B22 WD SSD M.2-2280/512GB/WD Black/PCIe Gen3 NVMe/5 /WDS512G1X0C 1 NUC NUC7i7BNH

More information

GNU Emacs GNU Emacs

GNU Emacs GNU Emacs GNU Emacs 2015 10 2 1 GNU Emacs 1 1.1....................................... 1 1.2....................................... 1 1.2.1..................................... 1 1.2.2.....................................

More information

写真集計くん+ for Mac ユーザーズガイド

写真集計くん+ for Mac ユーザーズガイド DPOF + Plus for Mac + for Mac 1 + for Mac 1 + for Mac 2 3 3 5 5 5 FTP 5 7 7 7 8 11 11 13 16 18 DPOF 23 23 FTP 24 25 26 26 26 26 + for Mac + for Mac + for Mac + for Mac ( ) DPE (DPOF) Microsoft Excel Visual

More information

Maser RNA-seq Genome Resequencing De novo Genome Sequencing Metagenome ChIP-seq CAGE BS-seq

Maser RNA-seq Genome Resequencing De novo Genome Sequencing Metagenome ChIP-seq CAGE BS-seq NGS Maser 2013/10/17 Maser RNA-seq Genome Resequencing De novo Genome Sequencing Metagenome ChIP-seq CAGE BS-seq Maser RNA-seq Genome Resequencing De novo Genome Sequencing Metagenome ChIP-seq CAGE BS-seq

More information

unix15-script2_09.key

unix15-script2_09.key UNIX講習会 シェルスクリプト2 31/July/2015 情報管理解析室 西出 浩世 SGE ~/unix15/sge $ cd ~/unix15/sge $ ls script* script2.sh script3.sh script4.sh ~/unix15/sge/results sam 12 $ ls results/*.sam $ rm -r results $ cp -r /usr/local/data/unix15/sge/results.

More information

MOMW_I_,II 利用ガイド.PDF

MOMW_I_,II 利用ガイド.PDF MOMW (I), II 1 The Making of the Modern World I. The Making of the Modern World... 2 II.... 3 II-1... 3 II-2 Basic Search... 4 II-3... 5 II-4 Advanced Search... 9 II-5... 13 III.... 14 III-1... 14 III-2...

More information

名称未設定

名称未設定 Parallels Desktop 4 for Mac ( 4.0.3846 ) Read Me : 1. Parallels Desktop 2. 3. 4. 5. 6. Parallels Desktop 7. Parallels Desktop 4 for Mac 8. Parallels Desktop 9. Parallels Desktop 10. 11. 12. 1. Parallels

More information

Introduction Purpose This training course demonstrates the use of the High-performance Embedded Workshop (HEW), a key tool for developing software for

Introduction Purpose This training course demonstrates the use of the High-performance Embedded Workshop (HEW), a key tool for developing software for Introduction Purpose This training course demonstrates the use of the High-performance Embedded Workshop (HEW), a key tool for developing software for embedded systems that use microcontrollers (MCUs)

More information

1. 1 DBMS Unix (USP ) ( )[3] 20 UNIX [2] KISS UNIX 1. 2 (Tukubai ) Unix OS Unix USP Tukubai Tukubai 1. 3 Unix SQL Tukubai usp Tukubai Open usp Tukubai

1. 1 DBMS Unix (USP ) ( )[3] 20 UNIX [2] KISS UNIX 1. 2 (Tukubai ) Unix OS Unix USP Tukubai Tukubai 1. 3 Unix SQL Tukubai usp Tukubai Open usp Tukubai 34 (2017 ) Unix UNIX 20 RDBMS RDBMS Java Unix Unix Unix Unicage is a system development method based on UNIX philosophy and has been applied on business system integration for 20 years. In these days,

More information

Microsoft Word - CATNewsVol2No7Text.doc

Microsoft Word - CATNewsVol2No7Text.doc COMPLEX ADAPTIVE TRAITS Newsletter 23 (3) The International Plant & Animal Genome XX Conference Vol. 2 No. 7 2011 DDBJ Sequence Read Archive (DRA) DDBJ Linux BLAST R DDBJ Sequence Read Archive (DRA) DRA

More information

K-BASIC 1st: ユニケージ基礎編(前編)

K-BASIC 1st: ユニケージ基礎編(前編) 5 2 AWK AWK AWK 2.1 AWK AWK UNIX OS 1977 UNIX Alfred Aho Peter Weinberger Brian Kernighan 3 AWK AWK /etc/resolv.conf DNS IP 1 [hoge@lecture ~]$ cat /etc/resolv.conf awk {print $2} 2 ---------- 3 4 8.8.8.8

More information

VLD Kazutoshi Kobayashi

VLD Kazutoshi Kobayashi VLD Kazutoshi Kobayashi (kobayasi@kuee.kyoto-u.ac.jp) 2005 8 26-29 1, Verilog-HDL, Verilog-HDL. Verilog-HDL,, FPGA,, HDL,. 1.1, 1. (a) (b) (c) FPGA (d). 2. 10,, Verilog-HDL, FPGA,. 1.2,,,, html. % netscape

More information

dvi

dvi { SSH { 3 3 1 telnet ID ( ) ID ( 1) SSH(Secure SHell) (ID ) SSH SSH SSH login : userid password : himitsu login : userid psaaword: himitsu login : userid password : himitsu 1. Host 11 7 UNIX ( sakura)

More information

プレゼンテーション3

プレゼンテーション3 ryamasi@hgc.jp >cdna_test CCCCTGCCCTCAACAAGATGTTTTGCCAACTGGCCAAGACCTGCCCTGTGCAGCTGTGGGTTGATTCCAC ACCCCCGCCCGGCACCCGCGTCCGCGCCATGGCCATCTACAAGCAGTCACAGCACATGACGGAGGTTGTG AGGCGCTGCCCCCACCATGAGCGCTGCTCAGATAGCGATGGTCTGGCCCCTCCTCAGCATCTTATCCGAG

More information

TC5.ids

TC5.ids % cp ~train00/.cshrc.iris ~ % cp ~train00/.alias.all ~ % exit UNIX の基本 シェルシステムとユーザの仲立ちをするプログラムであって ユーザが入力したコマンドを解釈して実行する Unix では文法によって sh 系と csh 系がある sh 系には sh, ash, zsh, bash などがある csh 系には csh, tcsh などがある

More information

スパコンに通じる並列プログラミングの基礎

スパコンに通じる並列プログラミングの基礎 2016.06.06 2016.06.06 1 / 60 2016.06.06 2 / 60 Windows, Mac Unix 0444-J 2016.06.06 3 / 60 Part I Unix GUI CUI: Unix, Windows, Mac OS Part II 0444-J 2016.06.06 4 / 60 ( : ) 6 6 ( ) 6 10 6 16 SX-ACE 6 17

More information

Microsoft Word - Meta70_Preferences.doc

Microsoft Word - Meta70_Preferences.doc Image Windows Preferences Edit, Preferences MetaMorph, MetaVue Image Windows Preferences Edit, Preferences Image Windows Preferences 1. Windows Image Placement: Acquire Overlay at Top Left Corner: 1 Acquire

More information

X Window System X X &

X Window System X X & 1 1 1.1 X Window System................................... 1 1.2 X......................................... 1 1.3 X &................................ 1 1.3.1 X.......................... 1 1.3.2 &....................................

More information

展開とプロビジョニングの概念

展開とプロビジョニングの概念 ADOBE CREATIVE SUITE 5 2010 Adobe Systems Incorporated and its licensors. All rights reserved. Adobe Creative Suite Deployment and Provisioning Concepts This guide is licensed for use under the terms of

More information

Compiled MODELSでのDFT位相検出装置のモデル化と評価

Compiled MODELSでのDFT位相検出装置のモデル化と評価 listsize TPBIG.EXE /Mingw32 ATP (Alternative Transients Program)- EMTP ATP ATP ATP ATP(TPBIG.EXE) EMTP (ATP)FORTAN77 DIMENSION C malloc listsize TACS DIMENSIONEMTP ATP(TPBIG.EXE) listsize (CPU ) RL 4040

More information

CpG (Whole genome bisulfite sequencing; WGBS) MeDip-Seq 1 DNA CpG-rich 1. SureSelect Reduced representation bisulfite sequencing (RRBS) DNA CpG PCR DN

CpG (Whole genome bisulfite sequencing; WGBS) MeDip-Seq 1 DNA CpG-rich 1. SureSelect Reduced representation bisulfite sequencing (RRBS) DNA CpG PCR DN Agilent SureSelect XT Human Methyl-Seq 1 DNA Agilent SureSelect XT Human Methyl-Seq 1 SureSelect DNA Agilent SureSelect XT Human Methyl-Seq 370 CpG Human Methyl- Seq CpG shore shelf CpG 4000 CpG 2kb CpG

More information

Antenna House PDF Server V3.1 ユーザーズマニュアル

Antenna House PDF Server V3.1 ユーザーズマニュアル http://www.microsoft.com/ja-jp/download/details.aspx?id=32 http://www.microsoft.com/ja-jp/download/details.aspx?id=1385 2 1 3 4 5 1 2 3 4 5 1 2 1 2 1 2 3 4 1 2 3 4 5 6 1 2 4 5 7 8 3 6 9 1

More information

01 01 01 01 01 Last login: Tue Jan 21 21:54:32 on ttys000 macbook:~ hisako$ 01 02 01 02 01 $ pwd /Users/hisako $ ls Applications Desktop Documents Downloads Dropbox Google Drive Library 03 01 03 Movies

More information

ソフトウェアについて Rev 年 1 月 16 日 このマニュアルでは標準でインストールしているソフトウェアの入手元 インストール方法の概要 インストール場所 についてご案内致します ABySS

ソフトウェアについて Rev 年 1 月 16 日 このマニュアルでは標準でインストールしているソフトウェアの入手元 インストール方法の概要 インストール場所 についてご案内致します ABySS このマニュアルでは標準でインストールしているソフトウェアの入手元 インストール方法の概要 インストール場所 についてご案内致します ABySS http://www.bcgsc.ca/platform/bioinfo/software/abyss/ abyss 1.3.4.tar.gz tar xvzf abyss 1.3.4.tar.gz cd abyss 1.3.4./configure prefix=/usr/local/abyss

More information

~~~~~~~~~~~~~~~~~~ wait Call CPU time 1, latch: library cache 7, latch: library cache lock 4, job scheduler co

~~~~~~~~~~~~~~~~~~ wait Call CPU time 1, latch: library cache 7, latch: library cache lock 4, job scheduler co 072 DB Magazine 2007 September ~~~~~~~~~~~~~~~~~~ wait Call CPU time 1,055 34.7 latch: library cache 7,278 750 103 24.7 latch: library cache lock 4,194 465 111 15.3 job scheduler coordinator slave wait

More information

チュートリアル XP Embedded 入門編

チュートリアル XP Embedded 入門編 TUT-0057 Ver. 1.0 www.interface.co.jp Ver 1.0 2005 6 (,), Web site () / () 2004 Interface Corporation. All rights reserved. ...1...1 1. XP Embedded...2 2....3 2.1....3 2.2....4 2.2.1. SLD...4 2.3....5

More information

B 20 Web

B 20 Web B 20 Web 0753018 21 1 29 1 1 6 2 8 3 UI 10 3.1........................ 10 3.2 Web............ 11 3.3......... 12 4 UI 14 4.1 Web....................... 15 4.2 Web........... 16 4.3 Web....................

More information

2

2 L C -24K 9 L C -22K 9 2 3 4 5 6 7 8 9 10 11 12 11 03 AM 04 05 0 PM 1 06 1 PM 07 00 00 08 2 PM 00 4 PM 011 011 021 041 061 081 051 071 1 2 4 6 8 5 7 00 00 00 00 00 00 00 00 30 00 09 00 15 10 3 PM 45 00

More information

Microsoft PowerPoint - SNGS_Ana講習会5月29日.pptx

Microsoft PowerPoint - SNGS_Ana講習会5月29日.pptx NGS analyzer: 次世代シークエンス解析プログラム 独立行政法人理化学研究所情報基盤センター HPCI 計算生命科学推進プログラム須永泰弘 2013/5/29 次世代シークエンス解析ソフト講習会 1 NGS analyzer とは? 次世代シークエンサー (NGS) からの塩基配列データを用いて マッピング PCR の除去 SNP タイピング 欠失挿入の検出を行う 一連の作業はパイプライン化してある

More information

Microsoft Word - D JP.docx

Microsoft Word - D JP.docx Application Service Gateway Thunder/AX Series vthunder ライセンスキー インストール 手順 1 1.... 3 2. vthunder... 3 3. ACOS... 3 4. ID... 5 5.... 8 6.... 8 61... 8 62 GUI... 10 2 1. 概要 2. vthunder へのアクセス 方法 SSHHTTPSvThunder

More information

20 H8/3069LAN H. Fukura

20 H8/3069LAN H. Fukura 20 H8/3069LAN 1.1 2009 2 9 H. Fukura 1 1 2 Cygwin 2 2.1................... 3 2.2................. 3 3 h8300-hms 13 3.1................... 14 3.2......... 14 3.3............. 35 3.4.............. 38 i

More information

quattro.PDF

quattro.PDF Quattro USB Audio Interface 2 M-AUDIO 3 Windows Windows 98 SE/ Windows ME/ Windows 2000/ Windows XP Platinum III 500MHz/ 96kHz Platinum II 400MKz/ 48kHz 128MB RAM / 96kHz 64MB RAM/ 48kHz Macintosh USB

More information

IonTorrent RNA-Seq 解析概要 サーモフィッシャーサイエンティフィックライフテクノロジーズジャパンテクニカルサポート The world leader in serving science

IonTorrent RNA-Seq 解析概要 サーモフィッシャーサイエンティフィックライフテクノロジーズジャパンテクニカルサポート The world leader in serving science IonTorrent RNA-Seq 解析概要 2017-03 サーモフィッシャーサイエンティフィックライフテクノロジーズジャパンテクニカルサポート The world leader in serving science 資料概要 この資料は IonTorrent シーケンサーで RNA-Seq (WholeTranscriptome mrna ampliseqrna mirna) 解析を実施されるユーザー様向けの内容となっています

More information

273? C

273? C TSG Theoretical Science Group 273? C 2-1.................................. 2 -1. Windows Mac Mac UNIX CUI bash >_ Finder TSG No.273? 2 3 pwd ls cd ( ) change directory 3 TSG No.273? cd hoge cd hoge cd....../

More information

EPSON ES-D200 パソコンでのスキャンガイド

EPSON ES-D200 パソコンでのスキャンガイド NPD4271-00 ...4...7 EPSON Scan... 7...11 PDF...12 / EPSON Scan...13 EPSON Scan...13 EPSON Scan...14 EPSON Scan...14 EPSON Scan...15 Epson Event Manager...16 Epson Event Manager...16 Epson Event Manager...16

More information

PowerPoint プレゼンテーション

PowerPoint プレゼンテーション Linux の基本操作 九州工業大学藤井聡 menu Linux の最低限の基礎 Linuxについて Linuxコマンド ソフトウェアのインストールから実行まで MACS2 で実践 Linux かぁ 次世代シーケンサ (NGS) に関係するソフトウェアが Windows で選択とクリックだけで済むものが少なく 解析できる手法にも限界が Linux 使えば良いと聞くが どうやって扱っていいのか Linux

More information

Parallels Desktop : Parallels Transporter ( VMware Microsoft Virtual PC VirtualBox ) Parallels Image Tool Parallels Mounter 2. ( build 5.0.9344 ) Para

Parallels Desktop : Parallels Transporter ( VMware Microsoft Virtual PC VirtualBox ) Parallels Image Tool Parallels Mounter 2. ( build 5.0.9344 ) Para Parallels Desktop 5 for Mac Read Me Parallels Desktop for Mac build 5.0.9344 Parallels Desktop for Mac : 1. Parallels Desktop for Mac 2. 3. 4. 5. Parallels Desktop 6. Parallels Desktop 5 for Mac 7. Parallels

More information

Building a Culture of Self- Access Learning at a Japanese University An Action Research Project Clair Taylor Gerald Talandis Jr. Michael Stout Keiko Omura Problem Action Research English Central Spring,

More information

OPA134/2134/4134('98.03)

OPA134/2134/4134('98.03) OPA OPA OPA OPA OPA OPA OPA OPA OPA TM µ Ω ± ± ± ± + OPA OPA OPA Offset Trim Offset Trim Out A V+ Out A Out D In +In V+ Output In A +In A A B Out B In B In A +In A A D In D +In D V NC V +In B V+ V +In

More information

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part Reservdelskatalog MIKASA MT65H vibratorstamp EPOX Maskin AB Postadress Besöksadress Telefon Fax e-post Hemsida Version Box 6060 Landsvägen 1 08-754 71 60 08-754 81 00 info@epox.se www.epox.se 1,0 192 06

More information

はじめに このドキュメントではftServerに関する障害調査を行う際に 必要となるログ データの取得方法を説明しています ログ データの取得には 初期解析用のデータの取得方法と 詳細な調査を行うときのデータ取得方法があります 特別な理由でOS 側のログが必要となった場合には RHELログの取得につ

はじめに このドキュメントではftServerに関する障害調査を行う際に 必要となるログ データの取得方法を説明しています ログ データの取得には 初期解析用のデータの取得方法と 詳細な調査を行うときのデータ取得方法があります 特別な理由でOS 側のログが必要となった場合には RHELログの取得につ ftserver におけるログ取得手順 (Linux 編 ) Rev 0.5: 2017/06/08 1 はじめに このドキュメントではftServerに関する障害調査を行う際に 必要となるログ データの取得方法を説明しています ログ データの取得には 初期解析用のデータの取得方法と 詳細な調査を行うときのデータ取得方法があります 特別な理由でOS 側のログが必要となった場合には RHELログの取得について

More information

206“ƒŁ\”ƒ-fl_“H„¤‰ZŁñ

206“ƒŁ\”ƒ-fl_“H„¤‰ZŁñ 51 206 51 63 2007 GIS 51 1 60 52 2 60 1 52 3 61 2 52 61 3 58 61 4 58 Summary 63 60 20022005 2004 40km 7,10025 2002 2005 19 3 19 GIS 2005GIS 2006 2002 2004 GIS 52 2062007 1 2004 GIS Fig.1 GIS ESRIArcView

More information

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part Reservdelskatalog MIKASA MVB-85 rullvibrator EPOX Maskin AB Postadress Besöksadress Telefon Fax e-post Hemsida Version Box 6060 Landsvägen 1 08-754 71 60 08-754 81 00 info@epox.se www.epox.se 1,0 192 06

More information

appli_HPhi_install

appli_HPhi_install 2018/3/7 HΦ version 3.0.0 インストール手順書 (Linux 64 ビット版 ) 目次 1. アプリケーション概要...- 1-2. システム環境...- 1-3. 必要なツール ライブラリのインストール...- 1-1 cmake...- 2-2 numpy...- 3-4. アプリケーションのインストール...- 4-5. 動作確認の実施...- 5 - 本手順書は HΦ

More information

/

/ / 1 UNIX AWK( ) 1.1 AWK AWK AWK A.V.Aho P.J.Weinberger B.W.Kernighan 3 UNIX AWK GNU AWK 1 1.2 1 mkdir ~/data data ( ) cd data 1 98 MS DOS FD 1 2 AWK 2.1 AWK 1 2 1 byte.data 1 byte.data 900 0 750 11 810

More information

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part Reservdelskatalog MIKASA MVC-50 vibratorplatta EPOX Maskin AB Postadress Besöksadress Telefon Fax e-post Hemsida Version Box 6060 Landsvägen 1 08-754 71 60 08-754 81 00 info@epox.se www.epox.se 1,0 192

More information

リード・ゲノム・アノテーションインポート

リード・ゲノム・アノテーションインポート リード ゲノム アノテーションインポート 1 Location と Folder ロケーション フォルダ Genomics Workbenchではデータを以下のような階層構造で保存可能です フォルダの一番上位の階層を Location と呼び その下の階層を Folder と呼びます データの保存場所はロケーション毎に設定可能です たとえばあるデータは C ドライブに保存し あるデータは D ドライブに保存するといった事が可能です

More information

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part

How to read the marks and remarks used in this parts book. Section 1 : Explanation of Code Use In MRK Column OO : Interchangeable between the new part Reservdelskatalog MIKASA MCD-L14 asfalt- och betongsåg EPOX Maskin AB Postadress Besöksadress Telefon Fax e-post Hemsida Version Box 6060 Landsvägen 1 08-754 71 60 08-754 81 00 info@epox.se www.epox.se

More information

GT-X830

GT-X830 NPD5108-00 ...5... 5... 6... 8...11 EPSON Scan...11 PDF...16 OCR...16...17...17...20 /...20...20...22...23...23...24...25...25...26...27 PDF...30...31 / EPSON Scan...34 EPSON Scan...34 EPSON Scan...36

More information

$ sudo apt-get install libavahi-compat-libdnssd-dev $ sudo apt-get autoremove nodejs $ wget http://nodejs.org/dist/latest/node-v7.6.0-linux-armv7l.tar.gz $ tar xzf node-v7.6.0-linux-armv7l.tar.gz $ sudo

More information

情報の分析 1. Linux ツールの活用

情報の分析 1. Linux ツールの活用 1. Linux Chris Plaintail June 16, 2016 1 / 39 1 Cygwin Cygwin 2 3 4 Cygwin 5 2 / 39 Uinux Unix OS Micorsoft Windows Cygwin Cygwin 3 / 39 Cygwin 4 / 39 Cygwin...is it? a large collection of GNU and Open

More information

etrust Access Control etrust Access Control UNIX(Linux, Windows) 2

etrust Access Control   etrust Access Control UNIX(Linux, Windows) 2 etrust Access Control etrust Access Control UNIX(Linux, Windows) 2 etrust Access Control etrust Access Control 3 ID 10 ID SU ID root 4 OS OS 2 aaa 3 5 TCP/IP outgoing incoming DMZ 6 OS setuid/setgid) OS

More information

DS-30

DS-30 NPD4633-00 JA ...6... 6... 6... 6... 6... 7... 7... 7... 7... 8... 8...9...10...11...11...13 Document Capture Pro Windows...13 EPSON Scan Mac OS X...14 SharePoint Windows...16 Windows...16...17 Document

More information

GT-X980

GT-X980 NPD5061-00 JA ...6...10...10...11...13...15...20...21...21...22 /...23 PDF...27 PDF...31 /...35...38...43...46 EPSON Scan...49...49...49...50 EPSON Scan...51...51...52...52...53 2 Windows...53 Mac OS X...53...53...53...54...56...56...58...59...60...60...61...62...63

More information

USB FDD ユーザーズマニュアル

USB FDD ユーザーズマニュアル Universal Serial Bus Interface External Floppy Disk Drive Unit USB FDD For USB FDD Driver CD-ROM P/N 139060-02 Copyright 1999-2001 Y-E Data, Inc. All Rights Reserved. USB FDD USB FDD USB FDD VCCI Adobe

More information

SonicStage Ver. 2.0

SonicStage Ver. 2.0 3-263-346-01(1) SonicStage Ver. 2.0 SonicStage SonicStage 2004 Sony Corporation Windows SonicStage OpenMG Net MD ATRAC ATRAC3 ATRAC3plus Microsoft Windows Windows NT Windows Media Microsoft Corporation

More information

橡Ⅳインストールマニュアル.PDF

橡Ⅳインストールマニュアル.PDF 1. IDWS... 1... 1 1.2... 1 1.3... 1... 2 Configuration... 2 Manager Configuration... 3 Plugin... 4 ID MIB... 4 Snort Output Plugin... 5 SML-XML Plugin... 9 MIB Plugin... 11 XML-SMI Plugin... 13 IDWS...

More information

卒業論文2.dvi

卒業論文2.dvi 15 GUI A study on the system to transfer a GUI sub-picture to the enlarging viewer for operational support 1040270 2004 2 27 GUI PC PC GUI Graphical User Interface PC GUI GUI PC GUI PC PC GUI i Abstract

More information

soturon.dvi

soturon.dvi 12 Exploration Method of Various Routes with Genetic Algorithm 1010369 2001 2 5 ( Genetic Algorithm: GA ) GA 2 3 Dijkstra Dijkstra i Abstract Exploration Method of Various Routes with Genetic Algorithm

More information

3.2 Linux root vi(vim) vi emacs emacs 4 Linux Kernel Linux Git 4.1 Git Git Linux Linux Linus Fedora root yum install global(debian Ubuntu apt-get inst

3.2 Linux root vi(vim) vi emacs emacs 4 Linux Kernel Linux Git 4.1 Git Git Linux Linux Linus Fedora root yum install global(debian Ubuntu apt-get inst 1 OS Linux OS OS Linux Kernel 900 1000 IPA( :http://www.ipa.go.jp/) 8 12 ( ) 16 ( ) 4 5 22 60 2 3 6 Linux Linux 2 LKML 3 3.1 Linux Fedora 13 Ubuntu Fedora CentOS 3.2 Linux root vi(vim) vi emacs emacs 4

More information

fx-9860G Manager PLUS_J

fx-9860G Manager PLUS_J fx-9860g J fx-9860g Manager PLUS http://edu.casio.jp k 1 k III 2 3 1. 2. 4 3. 4. 5 1. 2. 3. 4. 5. 1. 6 7 k 8 k 9 k 10 k 11 k k k 12 k k k 1 2 3 4 5 6 1 2 3 4 5 6 13 k 1 2 3 1 2 3 1 2 3 1 2 3 14 k a j.+-(),m1

More information

Infinium BeadChip COGS BeadChip 4 * iselect 3 SNP 25 1 SNP NGS Sequencing by Synthesis SBS HiSeq MiSeq WGS 1 RNA-Seq ChIP-Seq 1 1 * icogs BCAC OCAC PR

Infinium BeadChip COGS BeadChip 4 * iselect 3 SNP 25 1 SNP NGS Sequencing by Synthesis SBS HiSeq MiSeq WGS 1 RNA-Seq ChIP-Seq 1 1 * icogs BCAC OCAC PR Infinium BeadChip COGS BeadChip 4 * iselect 3 SNP 25 1 SNP NGS Sequencing by SynthesisSBSHiSeq MiSeq WGS 1 RNA-Seq ChIP-Seq 1 1 * icogs BCACOCAC PRACTICALBRCA1/2 CIMBA www.illuminakk.co.jp DNA CE DNA DNA

More information