본문 바로가기

RNA13

WEB-based analysis TIMER : A Web Server for Comprehensive Analysis of Tumor-Infiltrating Immune Cells > TIMER, https://doi.org/10.1158/0008-5472.CAN-17-0307 > TIMER2.0, https://doi.org/10.1093/nar/gkaa407 http://timer.cistrome.org/ http://timer.comp-genomics.org/ GEPIA : Gene Expression Profiling Interactive Analysis > GEPIA, https://doi.org/10.1093/nar/gkx247 > GEPIA2, https://doi.org/10.1093/nar/gkz430 > GEPIA20.. 2021. 11. 30.
RNA velocity 보통 우리가 다루는 RNA 데이터는 한 시점에 채취한 혈액이나 tissue에서 얻은 것이다. 즉, 시간에 따라 cell이 어떻게 변화하는지 알 수 없는 정적인 데이터이다. 이러한 정적인 데이터로부터, unspliced mRNA 와 spliced mRNA 의 비율을 통해 cell fate, cell lineage, dynamic pathway 또는 cellular differentiation 를 추정하는 방법이 있다. (RNA velocity of single cells, 2018) 좀 더 robust한 방법으로 likelihood-based dynamic model이 있다. (Generalizing RNA velocity to transient cell states through dynamical mod.. 2021. 11. 2.
[R] Enhanced Volcano plot sudo apt install libfribidi-dev libfreetype6-dev libpng-dev libtiff5-dev libjpeg-dev BiocManager::install('EnhancedVolcano') https://github.com/kevinblighe/EnhancedVolcano dds 2021. 10. 12.
[R] boxplot options https://r-charts.com/distribution/boxplot-function/ pdf(paste0(fname, "_non_vs_normalized.pdf")) par(mar=c(1, 4, 2, 1)) par(mfrow = c(2, 1)) boxplot(log_ndds, notch=TRUE, main = "Non-normalized read counts", ylab="log2(read counts + 1)", names=NA, cex = .2, col = meta$color, border = 8, medcol = 3, outlwd = 0.5, boxlwd = 0.1, whisklwd =0.2) boxplot(log_dds, notch=TRUE, main = "Size-factor-normal.. 2021. 10. 6.
GSEA GSEA ( Gene Set Enrichment Analysis ) : 오믹스 데이터 분석을 통해서 최종적인 gene set을 찾게 되었을 때, 이것들의 pathway는 어디에서 많이 보이는지 찾아주는 라이브러리이다. - Homepage : https://www.gsea-msigdb.org/gsea/index.jsp - Pape : https://doi.org/10.1073/pnas.0506580102 - Github : https://github.com/zqfang/GSEApy - Tutorial : https://gseapy.readthedocs.io/en/latest/introduction.html $ pip install gseapy - Gene set library : https://maayan.. 2021. 10. 1.
SCSA - scRNA-seq Annotation SCSA: cell type annotation for single-cell RNA-seq data - Paper : https://www.frontiersin.org/articles/10.3389/fgene.2020.00490/full - Github : https://github.com/bioinfo-ibms-pumc/SCSA 더보기 DB format : two-column data table, [ 'cell-type', 'marker-gene'] from CellMarker Cell marker Cell type Tissue HUMAN 11464 456 158 MOUSE 7855 385 80 and CancerSEA, https://github.com/camlab-bioml/cancersea : 1.. 2021. 9. 1.
TCGA data https://portal.gdc.cancer.gov/repository TCGA 에서는 DNA와 RNA 데이터를 여러가지 형태로 제공한다. 다음의 순서로 원하는 데이터를 다운로드 받는다. 데이터 정보 ( aligned by GRCh38 ) : https://docs.gdc.cancer.gov/Encyclopedia/pages/RNA-Seq/ 1. 데이터 선택 : [ Files ] 탭에서 데이터 분류를 선택하고, [ Cases ] 탭에서 데이터 종류를 선택한다. 2. 그래프 위쪽 부분에 [ Manifest ] 버튼을 눌러 데이터 리스트를 다운로드 받는다. : gdc_manifest.2021-08-27.txt 3. 데이터 정보를 JSON 형태로 다운로드 받는다. : files.2021-08-27.json .. 2021. 8. 30.
scRNA-seq analysis 기존 bulk방식의 RNA-seq 데이터의 수집 및 분석 방식과 single cell RNA-seq 방식의 차이는 다음과 같다. Process for barcoding single-cell data 더보기 Remove Doublet 더보기 Gene cell-type annotation 더보기 DB - CellMarker : http://biocc.hrbmu.edu.cn/CellMarker/ - CanserSEA : http://biocc.hrbmu.edu.cn/CancerSEA/home.jsp Software - SCSA (python) : https://github.com/bioinfo-ibms-pumc/SCSA - scMatch (python) : https://github.com/asrhou/scM.. 2021. 8. 19.
Single Cell analysis tools 1. Scanpy [ python ] - Github : https://github.com/theislab/scanpy - Paper : https://genomebiology.biomedcentral.com/articles/10.1186/s13059-017-1382-0 - Tutorial : https://scanpy.readthedocs.io/en/stable/tutorials.html : https://training.galaxyproject.org/training-material/topics/transcriptomics/tutorials/scrna-scanpy-pbmc3k/tutorial.html # https://docs.conda.io/en/latest/miniconda.html cd DOWN.. 2021. 8. 13.
[paper] RNA-seq expression Differential Transcript Usage Analysis Incorporating Quantification Uncertainty via Compositional Measurement Error Regression Modeling ... Commonly used quantities for RNA-seq transcript isoform expression include Transcripts Per Million (TPM) (Wagner, Kin and Lynch, 2012), which provides a transcript-length and library size normalized estimate of expression for each transcript isoform within a.. 2021. 6. 9.
DESeq2 - Library normalization $ conda install gxx_linux-64 DESeq2 if (!requireNamespace("BiocManager", quietly = TRUE)) install.packages("BiocManager") BiocManager::install("tximport") BiocManager::install("DESeq2") https://bioconductor.org/packages/release/bioc/vignettes/DESeq2/inst/doc/DESeq2.html https://sites.tufts.edu/biotools/files/2019/04/bioinformatics_for_rnaseq_day2.pdf library(DESeq2) library(vsn) library(ggplot2).. 2021. 5. 18.
Gene expression Terminology - RPKM (Reads Per Kilobase Million) is for single end RNA-seq. - FPKM (Fragments Per Kilobase Million) is for paired end RNA-seq. - TPM (Transcripts Per Million) - Gene-level quantification : count the number of reads that map (i.e. align) to each gene (read count) - library : In molecular biology, a library is a collection of DNA fragments that is stored and propagated in a populati.. 2021. 5. 18.
mRNA Vaccine mRNA 백신은 mRNA가 코팅되어 있고, 팔뚝에 주사하게 된다. 주입된 mRNA는 세포로 들어가게되고, 리보솜으로 간다. 리보솜에서 mRNA를 읽어 스파이크 단백질(piece of spike protein)을 만든다. 이후, 스파이크 단백질을 만드는데 관여했던 mRNA는 RNases에 의해 파괴된다. ( Vaccine mRNA는 세포핵에 들어가지 않고, 세포의 DNA를 바꾸지 않는다. ) 생성된 스파이크는 세포 표면으로 올라간다. immune system에 의해 스파이크가 붙은 세포는 정상세포가 아님을 인식하도록 하게되고, B lymphocytes 에서 antibody를 만들도록 한다. 바이러스가 침투하면, 만들어진 antibody는 바이러스 spike에 달라붙게 되고, 이 세포를 dendritic c.. 2021. 5. 8.