# RNA-seq **Repository Path**: bioinfoFungi/rna-seq ## Basic Information - **Project Name**: RNA-seq - **Description**: No description available - **Primary Language**: Unknown - **License**: Not specified - **Default Branch**: master - **Homepage**: None - **GVP Project**: No ## Statistics - **Stars**: 0 - **Forks**: 0 - **Created**: 2022-03-06 - **Last Updated**: 2022-03-06 ## Categories & Tags **Categories**: Uncategorized **Tags**: None ## README ``` . ├── cutadapt_fastq │   ├── cutadapt.sh │   ├── fastqc.sh │   ├── test_R1_cutadapt_fastqc.html │   ├── test_R1_cutadapt_fastqc.zip │   ├── test_R1_cutadapt.fq.gz │   ├── test_R2_cutadapt_fastqc.html │   ├── test_R2_cutadapt_fastqc.zip │   └── test_R2_cutadapt.fq.gz ├── data │   ├── chr1.fa │   ├── hg38_refseq.gtf │   ├── test_R1.fq.gz │   └── test_R2.fq.gz ├── fastqc_out │   ├── fastqc.sh │   ├── test_R1_fastqc.html │   ├── test_R1_fastqc.zip │   ├── test_R2_fastqc.html │   └── test_R2_fastqc.zip ├── hisat2_index │   ├── hg38_ch1.1.ht2 │   ├── hg38_ch1.2.ht2 │   ├── hg38_ch1.3.ht2 │   ├── hg38_ch1.4.ht2 │   ├── hg38_ch1.5.ht2 │   ├── hg38_ch1.6.ht2 │   ├── hg38_ch1.7.ht2 │   ├── hg38_ch1.8.ht2 │   ├── hisat2-build.log │   ├── hisat2-index.log │   └── hisat2_index.sh ├── hisat2_mapping │   ├── hisat2_mapping.log │   ├── hisat2_mapping.sh │   └── hisat2.sam ├── star_index │   ├── chrLength.txt │   ├── chrNameLength.txt │   ├── chrName.txt │   ├── chrStart.txt │   ├── exonGeTrInfo.tab │   ├── exonInfo.tab │   ├── geneInfo.tab │   ├── Genome │   ├── genomeParameters.txt │   ├── Log.out │   ├── SA │   ├── SAindex │   ├── sjdbInfo.txt │   ├── sjdbList.fromGTF.out.tab │   ├── sjdbList.out.tab │   ├── star_index--genomeFastaFiles │   │   └── Log.out │   ├── star_index.log │   ├── star_index.sh │   └── transcriptInfo.tab ├── star_mapping │   ├── starAligned.out.bam │   ├── starLog.final.out │   ├── starLog.out │   ├── starLog.progress.out │   ├── star_mapping.log │   ├── star_mapping.sh │   └── starSJ.out.tab ├── tophat_index │   ├── chr1_ref_hg38.fa.1.bt2 │   ├── chr1_ref_hg38.fa.2.bt2 │   ├── chr1_ref_hg38.fa.3.bt2 │   ├── chr1_ref_hg38.fa.4.bt2 │   ├── chr1_ref_hg38.fa.rev.1.bt2 │   ├── chr1_ref_hg38.fa.rev.2.bt2 │   ├── tophat2_index.log │   └── tophat_index.sh └── tophat_mapping ├── accepted_hits.bam ├── align_summary.txt ├── deletions.bed ├── insertions.bed ├── junctions.bed ├── logs │   ├── bam_merge_um.log │   ├── bowtie_build.log │   ├── bowtie_inspect_recons.log │   ├── bowtie.left_kept_reads.log │   ├── bowtie.left_kept_reads.m2g_um.log │   ├── bowtie.left_kept_reads.m2g_um_seg1.log │   ├── bowtie.left_kept_reads.m2g_um_seg2.log │   ├── bowtie.left_kept_reads.m2g_um_seg3.log │   ├── bowtie.left_kept_reads.m2g_um_seg4.log │   ├── bowtie.right_kept_reads.log │   ├── bowtie.right_kept_reads.m2g_um.log │   ├── bowtie.right_kept_reads.m2g_um_seg1.log │   ├── bowtie.right_kept_reads.m2g_um_seg2.log │   ├── bowtie.right_kept_reads.m2g_um_seg3.log │   ├── bowtie.right_kept_reads.m2g_um_seg4.log │   ├── g2f.err │   ├── g2f.out │   ├── gtf_juncs.log │   ├── juncs_db.log │   ├── long_spanning_reads.segs.log │   ├── m2g_left_kept_reads.err │   ├── m2g_left_kept_reads.out │   ├── m2g_right_kept_reads.err │   ├── m2g_right_kept_reads.out │   ├── prep_reads.log │   ├── reports.log │   ├── reports.samtools_sort.log0 │   ├── run.log │   ├── segment_juncs.log │   └── tophat.log ├── prep_reads.info ├── tophat2_mapping.log ├── tophat_mapping.sh └── unmapped.bam ```