Single Cell Genomics, Transcriptomics & Proteomics
Single Cell Genomics, Transcriptomics & Proteomics
  • Видео 181
  • Просмотров 257 038

Видео

Spatial Transcriptomics Data Deconvolution with cell2location in Python
Просмотров 3442 месяца назад
Spatial Transcriptomics Data Deconvolution cell2location Python
Spatial Data Analysis using STutility: Non-negative Matrix Factorization (NMF)
Просмотров 1622 месяца назад
spatial transcriptomics data STutility Non-negative Matrix Factorization (NMF)
Spatial Data Deconvolution using Robust Cell Type Decomposition (RCTD) Part II
Просмотров 3283 месяца назад
Spatial Data Deconvolution using Robust Cell Type Decomposition (RCTD) Part II
Spatial Data Deconvolution using Robust Cell Type Decomposition (RCTD) Part I
Просмотров 4453 месяца назад
Spatial Data Deconvolution using Robust Cell Type Decomposition (RCTD) Part I
Spatial Data Analysis In QuPath: How to Perform Multiplexed Analysis using Machine Learning method
Просмотров 3043 месяца назад
Spatial Data Analysis In QuPath: How to Perform Multiplexed Analysis using Machine Learning method
Spatial Data Analysis In QuPath:How to Perform Multiplexed Analysis using Simple Thresholding Method
Просмотров 2973 месяца назад
Spatial Data Analysis In QuPath: How to Perform Multiplexed Analysis using Simple Thresholding Method
Spatial Data Analysis Using QuPath: How to Perform Cell Segmentation Using StarDist in QuPath
Просмотров 2543 месяца назад
Spatial Data Analysis Using QuPath: How to Perform Cell Segmentation Using StarDist in QuPath
Cell-cell Communication Analysis:How to use the Liana package
Просмотров 6013 месяца назад
Cell-cell Communication Analysis:How to use the Liana package
Running Cell Ranger count
Просмотров 2834 месяца назад
Running Cell Ranger count
Download and Install Cell Ranger
Просмотров 2494 месяца назад
How to download and install Cell Ranger on high performance computer
How to download raw scRNA-seq data from NCBI using sratoolkit
Просмотров 2974 месяца назад
How to download raw scRNA-seq data from NCBI using sratoolkit
Nanostring CosMx 19K Gene Panel: Human Pancreas Spatial Dataset
Просмотров 3186 месяцев назад
Nanostring CosMx 19K Gene Panel: Human Pancreas Spatial Dataset
Nanostring CosMx Mouse Neuroscience RNA Panel
Просмотров 5897 месяцев назад
Nanostring CosMx, Mouse brain, Spatial data analysis
Converting Seurat Object into Scanpy Object in R Markdown
Просмотров 4438 месяцев назад
Scanpy, Seurat, R Markdown, R environment, scRNA-seq
Converting Scanpy Object into Seurat Object in R Markdown
Просмотров 3868 месяцев назад
Converting Scanpy Object into Seurat Object in R Markdown
Analzye Visium High Definition Spatial Dataset with Seurat
Просмотров 2 тыс.8 месяцев назад
Analzye Visium High Definition Spatial Dataset with Seurat
Recreate Seurat Cell Clusters from Xenium Onboard Analysis
Просмотров 6358 месяцев назад
Recreate Seurat Cell Clusters from Xenium Onboard Analysis
Microbiome Data Analysis Video 3: Create a phyloseq object
Просмотров 6168 месяцев назад
Microbiome Data Analysis Video 3: Create a phyloseq object
Microbiome Data Analysis in R--Video 2: Prepare otu_table from raw fastq files
Просмотров 3738 месяцев назад
Microbiome Data Analysis in R Video 2: Prepare otu_table from raw fastq files
Microbiome Data Analysis in R--Video 1: Prepare otu_table from raw fastq files
Просмотров 8208 месяцев назад
Microbiome Data Analysis in R Video 1: Prepare otu_table from raw fastq files
Identify Doublets using Doubletdetection Package in Python
Просмотров 2789 месяцев назад
Identify Doublets using Doubletdetection Package in Python
Identify Doublets using Scrublet Package in Scanpy
Просмотров 3839 месяцев назад
Identify Doublets using Scrublet Package in Scanpy
Build Metacells with SuperCell & Analyse Metacells with Seurat
Просмотров 4029 месяцев назад
Build Metacells with SuperCell & Analyse Metacells with Seurat
Create Volcano Plot using the EnhancedVolcano Package
Просмотров 8819 месяцев назад
Create Volcano Plot using the EnhancedVolcano Package
SEACell Video Tutorial 2: Create Metacells from scRNA-seq Data
Просмотров 2569 месяцев назад
SEACell Video Tutorial 2: Create Metacells from scRNA-seq Data
SEACell Video Tutorial 1: Create Metacells from scRNA-seq Data
Просмотров 5699 месяцев назад
SEACell Video Tutorial 1: Create Metacells from scRNA-seq Data
CellRank Video Tutorial 7: Cluster Genes with Similar Expression Trends
Просмотров 3639 месяцев назад
CellRank Video Tutorial 7: Cluster Genes with Similar Expression Trends
CellRank Video Tutorial 6: Visualize Gene Expression Trends
Просмотров 30710 месяцев назад
CellRank Video Tutorial 6: Visualize Gene Expression Trends
CellRank Video Tutorial 5: Uncover Driver Genes
Просмотров 27910 месяцев назад
CellRank Video Tutorial 5: Uncover Driver Genes

Комментарии

  • @zaidshaikh9245
    @zaidshaikh9245 3 дня назад

    I tried to run this script, only faced 1 issue with 'i' object not found. It has to be defined first before we include it in for loop.

  • @rahmavlog990
    @rahmavlog990 3 дня назад

    Thank you for sharing. Where I can download the human_mouse_gene_orthologues_csv?

  • @nagyferenc969
    @nagyferenc969 7 дней назад

    If you are using Seurat V5: at 3:14 instead of the code MergedNML@assays[["RNA"]]@data@x you can write MergedNML[["RNA"]]@layers[["counts.NML_I"]]@x This will show the matrix for NML_I, and you can view the others by changing NML_I to NML_II or NML_III. At 6:10 instead of MergedNML@assays[["RNA"]]@var.features you can write VariableFeatures(MergedNML)

  • @QuratUlAinHayderQurat
    @QuratUlAinHayderQurat 9 дней назад

    Hello Professor, I am working on scRNA data by following your videos I get an error on PCA analysis. MergedNML <- RunPCA(MergedNML) Error in PrepDR(object = object, features = features, verbose = verbose) : Variable features haven't been set. Run FindVariableFeatures() or provide a vector of feature names. How to resolve this error. I am using Seurat version 4

  • @lukesimpson1507
    @lukesimpson1507 11 дней назад

    Great video! Out of curiosity do you know if there is a way to perform CellRank using integrated data?

    • @Collection_of_online_tutorials
      @Collection_of_online_tutorials 11 дней назад

      you can, but you will need all the RNA velocity information

    • @lukesimpson1507
      @lukesimpson1507 11 дней назад

      @@Collection_of_online_tutorials Do you use the integrated or uncorrected assay for the object?

  • @mehwishmajeed1122
    @mehwishmajeed1122 20 дней назад

    I am getting error while doing adjacency matrix. Cannot allocate a vector of size 37gb how to solve it? I am working with 16gb ram/ 1TB storage laptop

  • @JoyceHilario-gq6se
    @JoyceHilario-gq6se 21 день назад

    Thank you! This helps me a lot! I successfully changed the name but when I do a subsequent analysis in my seurat, I get an error message that says, subscript out of bounds. Is this caused by genes without equivalent annotation? How to troubleshoot this?

    • @Collection_of_online_tutorials
      @Collection_of_online_tutorials 21 день назад

      can you post your analysis code and full error message, I can provide online one to one lesson to help you if you like

    • @JoyceHilario-gq6se
      @JoyceHilario-gq6se 21 день назад

      @@Collection_of_online_tutorials Thank you so much! In context, I was trying to analyze an HNSCC single cell data and plan to replace the ensemble gene ID into gene name before QC and filtering. So, I used followed your code for changing the name: library(EnsDb.Hsapiens.v86) Gene_ID<- hnscc@assays[["RNA"]]@counts@Dimnames[[1]] Gene_ID <- as.data.frame(Gene_ID) gene_name <-mapIds(EnsDb.Hsapiens.v86, keys = Gene_ID$Gene_ID, keytype = 'GENEID', column = 'SYMBOL') gene_name <- as.data.frame(gene_name) gene_name$gene_ids <- Gene_ID [["Gene_ID"]] hnscc@assays[["RNA"]]@counts@Dimnames[[1]] <- gene_name [["gene_name"]] This works well and I manage to see and filter my mitochondrial genes. But, when I want to subset my data to remove low quality cells, I get this error message: Error in .subscript.2ary(x, i, j, drop = drop) : subscript out of bounds

  • @alessandrogagliardi7470
    @alessandrogagliardi7470 26 дней назад

    quick question: shouldn't GSEA be applied on the complete set of genes with respective logFC? here, FindMarkers function produces a matrix with only differentiated genes across conditions.

  • @ramlielones7195
    @ramlielones7195 26 дней назад

    it is very helpful

  • @arianescajeda639
    @arianescajeda639 28 дней назад

    I think in minute 23 you got the same cluster becosue you are graphin using the idents from seurat not the clusters generated by monocle.

  • @magipassolsmanzano5550
    @magipassolsmanzano5550 Месяц назад

    You are a true hero professor! <3

  • @Sol-j2p
    @Sol-j2p Месяц назад

    Thanks ❤

  • @hendarasena3053
    @hendarasena3053 Месяц назад

    hi, can i ask question i encountered problem which some cells annotated as epithelial cells in level 1 annnotation by azimuth but if i look upon the finest level annotation, some of those epithelial cells (in level 1), annotated as non epithelial cells (like cd8, cd4, endothelials, and etc). though the amount of cell population that may misidientified is significantly few compared to majority of the cells when i look upon cannonical markers, it seems like some of the cells belong to epithelial cells are not expressing EPCAM how to solve this problem?

  • @IceCreamMT
    @IceCreamMT Месяц назад

    How do you convert csv file into seurat object?

  • @IceCreamMT
    @IceCreamMT Месяц назад

    How do you convert loaded csv files in R to seurat format? In this case do you still need the Read10x() function? Do I put the csv into seurat object somehow by CreateSeuratObject?

  • @АнастасияПетухова-в4ь

    Thank you for the tutorial! How can I download scripts from akoyabio?

  • @rahmafridayana5870
    @rahmafridayana5870 Месяц назад

    hello, it is really help me for my analysis. can I request that you can make a video which comparing the gene expression between two different species, like mouse and human. I wanna compare my subset fibroblast cells between mouse and human. But I don't know how. thank you~

  • @苏秋羊
    @苏秋羊 Месяц назад

    Professor, thanks for your video. I have one question, could i use scDblfinder with mergerd data? Thanks.

  • @shweatamaurya
    @shweatamaurya Месяц назад

    Thank you for this clear and easy-to-follow tutorial! I have a query: I have an RDS file that contains a list, where one part is an RNA Seurat object and the other is a dataframe. I need to convert this RDS file into an HDF5 format for downstream analysis. Would it be okay to follow this tutorial to convert just the Seurat object to an h5ad file, and handle the dataframe separately? Or is there a recommended way to include both components in the conversion process?

    • @Collection_of_online_tutorials
      @Collection_of_online_tutorials Месяц назад

      it only converts your Seurat object

    • @shweatamaurya
      @shweatamaurya Месяц назад

      @@Collection_of_online_tutorials Thank you, I have followed your this tutorial and converted Seurat object which is in rds file to h5ad file successfully. your video is very easy to follow and informative. Thanks again for posting it

  • @OsamaElghawil
    @OsamaElghawil Месяц назад

    I do 4 groups ,

  • @Sol-j2p
    @Sol-j2p Месяц назад

    Thanks professor. if you could share the notebook, that would be very helpful. Thank you for your effort !

  • @wangxuefeng6058
    @wangxuefeng6058 Месяц назад

    How come your computational speed is so fast! Care to share configurations?

  • @limkaishi6081
    @limkaishi6081 2 месяца назад

    Hi, thank you so much for the videos. It helps me a lottttt!!!!🤩🤩

  • @cloudrice7878
    @cloudrice7878 2 месяца назад

    How can I modify the seurat object's barcode to be the same as combined TCR-seq's barcode?

  • @magipassolsmanzano5550
    @magipassolsmanzano5550 2 месяца назад

    Thank you so much Dr!

  • @iot3136
    @iot3136 2 месяца назад

    Hi , Could you please do a video to teach Bioconductor SummarisedExperiment S4

  • @Sol-j2p
    @Sol-j2p 2 месяца назад

    Looking forward to more analysis using super computer/linux for sequencing

  • @duy703
    @duy703 2 месяца назад

    thank you professor the video is so nice, i wonder if you can add the subtitle for the vid. This vid help me so much

  • @Sol-j2p
    @Sol-j2p 2 месяца назад

    Love it ❤. You are the light of beginners. Could you do more on Super Computer.

  • @Sol-j2p
    @Sol-j2p 2 месяца назад

    Probably it is a bit off-topic here. If you have time, could you have some tutorials on how to use R and python in Super Computer? I have access to Super computer at workplace, but the HPC team didn't provide support on how to use R and Python in super computer to analyse data and sequencing data. You may have good tips and would be helpful to viewers.

  • @NAVYAB-eb2jp
    @NAVYAB-eb2jp 2 месяца назад

    If i downloaded dataa from geo dataset with barcode.tsv, matrix.mtx, fetaure.tsv and image.jpg.. how to create seurat object and process

  • @ely4529
    @ely4529 2 месяца назад

    What a saviour

  • @navyav.b8572
    @navyav.b8572 2 месяца назад

    I am having a doubt.. i have 6 sample and i done all procedure including intergration and find clusters etc.. i got about 26 clusters..further I proceeded with find marker genes for each clusters ..is that means 26 cluster will be 26 different cell type.. can i run this type of feature plots based on marker genes apart from find marker function and can chnage the cluster name....pls help to rectify the same..

  • @mikhailolferiev7906
    @mikhailolferiev7906 2 месяца назад

    How to split them and rename into reads and technical runs?

  • @chinhdoan9097
    @chinhdoan9097 2 месяца назад

    Thank you for the helpful video! I got weird result when do cell type annotation using seurat method. May I know if we can apply cell2location output to cellchat? Thank you so much!

    • @Collection_of_online_tutorials
      @Collection_of_online_tutorials 2 месяца назад

      yes, you can

    • @chinhdoan9097
      @chinhdoan9097 2 месяца назад

      @@Collection_of_online_tutorials the output of cell2location is python so we need to convert to seurat object for cellchat which use R? Would you please explain a little bit more and provide the script in this tutorial? Thank you!

    • @chinhdoan9097
      @chinhdoan9097 2 месяца назад

      @@Collection_of_online_tutorials Hi, I found this paper benchmarking their method with other method like cell2location. pmc.ncbi.nlm.nih.gov/articles/PMC10692090/

  • @Collection_of_online_tutorials
    @Collection_of_online_tutorials 2 месяца назад

    library(STutility) # built to work on top of Seurat, NMF implemented as RunNMF library(tidyverse) library(RColorBrewer) ### 1. Prepare data: 10X Visium data samples <- "data/V1_Adult_Mouse_Brain_filtered_feature_bc_matrix.h5" spotfiles <- "data/tissue_positions.csv" json <- "data/scalefactors_json.json" imgs <- "data/tissue_hires_image.png" infoTable <- data.frame(samples, imgs, spotfiles, json) se <- InputFromTable(infoTable, min.gene.count = 100, min.gene.spots = 5, min.spot.count = 500, platform = "Visium") cscale <- c("lightgray", "mistyrose", "red", "darkred", "black") ST.FeaturePlot(se, features = c("nFeature_RNA","nCount_RNA"), cols = cscale, ncol = 2, pt.size = 1.85) ### 2. Load the image se <- LoadImages(se, time.resolve = FALSE, verbose = TRUE) ImagePlot(se, method = "raster", type = "raw") se <- MaskImages(object = se) ImagePlot(se, method = "raster", type = "masked") # Masked image ### 3. NormalizeData, FindVariableFeatures and ScaleData se <- SCTransform(se) view(se@meta.data) ST.FeaturePlot(se, features = c("Cck", "Mbp"), pt.size = 2, cols = cscale) FeatureOverlay(se, features = c("Cck", "Mbp"), cols = cscale, pt.size = 2, type = "raw") ### 4. non-negative matrix factorization (NMF) dimensional reduction se <- RunNMF(se, nfactors = 40) # choose the number of factors, default = 20 ST.DimPlot(se, dims = 4:5, # 1:40 ncol = 2, grid.ncol = 2, reduction = "NMF", pt.size = 1.5, center.zero = F, cols = cscale, show.sb = FALSE) # print a summary of the genes that contribute most to the dimensionality reduction vectors print(se[["NMF"]]) # barplot to summarize the top most contributing genes for each factor FactorGeneLoadingPlot(se, factor = 1) ### 5. Clustering se <- FindNeighbors(object = se, verbose = T, reduction = "NMF", dims = 1:40) se <- FindClusters(object = se, reduction = "NMF", verbose = T) view(se@meta.data) VlnPlot(se, features = c("Olig1", "Th"), group.by = "seurat_clusters") # plot the clusters spatially qual_col_pals = brewer.pal.info[brewer.pal.info$category == 'qual',] col_vector = unlist(mapply(brewer.pal, qual_col_pals$maxcolors, rownames(qual_col_pals))) ST.FeaturePlot(object = se, features = "seurat_clusters", cols = col_vector, pt.size = 2)

  • @gradstudent91
    @gradstudent91 2 месяца назад

    Could you please help me I am following your tutorial and when I get to the count.sums, I cannot go any further. In the table there seems to be a normalizing of the cell numbers. I have over 10000 cells in some clusters but when I look at the number of cells present in the table I get 100, 500 etc. Somehow the cell number is not translating the proper raw cell numbers so when I run the dot plot I do not get proper sizing

  • @gaohaohao
    @gaohaohao 2 месяца назад

    good course!!!

  • @chinhdoan9097
    @chinhdoan9097 3 месяца назад

    Thank you so much for the helpful videos. I watched your channel for a long time. When I run FindTransferAnchors(), I got Warning: Layer counts isn't present in the assay object; returning NULL. And many cell types suppose to present when using SpatialFeaturePlot() have zero score. Can't upload a plot here. Would you please have a suggestion? Thank you so much!

  • @jawswasnevermyscene4258
    @jawswasnevermyscene4258 3 месяца назад

    Thank you so much for posting this. Hope to see more of cellranger

  • @hya995a
    @hya995a 3 месяца назад

    could not read H5, need to install hdf5r, how to solve this problems

  • @seyedtalebhouseini3360
    @seyedtalebhouseini3360 3 месяца назад

    Hello and respect Special thanks for your useful videos I have an important question. I would appreciate it if you could help me I have performed spatial transcriptome data analysis (Visium HD) for colorectal cancer as instructed in your videos If we analyze the spatial transcriptomics data and want to continue the QuPath analysis, how should we find the file related to the QuPath software that is related to colorectal cancer? And related to the results of our analysis? I mean, how can we find the qptiff file that you upload in QuPath software for colorectal cancer? With great respect

  • @hya995a
    @hya995a 3 месяца назад

    I dont have Library(tidyverse), Any suggestion?

  • @PaolaPibiri-d5l
    @PaolaPibiri-d5l 3 месяца назад

    Is this a pipeline for Xenium data alone, or includes the single-cell RNA data in it ?

  • @saleenay1879
    @saleenay1879 3 месяца назад

    I have one more doubt, if we are using only one sample, then can we use fgsea, is it make any sense.

  • @alkarani01
    @alkarani01 3 месяца назад

    How can I analyse single .tsv file on R using Seurat? e.g. GEO - GSE249493

  • @Collection_of_online_tutorials
    @Collection_of_online_tutorials 3 месяца назад

    library(Seurat) library(spacexr) library(tidyverse) set.seed(12345) ### Load Visium HD data cortex <- Load10X_Spatial(data.dir = "../Seurat/Visium_HD/", bin.size = 8) # bin.size = C(2,8,16) cortex <- NormalizeData(cortex) cortex <- FindVariableFeatures(cortex) cortex <- ScaleData(cortex) # sketch the cortical subset of the Visium HD dataset cortex <- SketchData(object = cortex, ncells = 50000, method = "LeverageScore", sketched.assay = "sketch") DefaultAssay(cortex) <- "sketch" cortex <- FindVariableFeatures(cortex) cortex <- ScaleData(cortex) cortex <- RunPCA(cortex, assay = "sketch", reduction.name = "pca.cortex.sketch", verbose = T) cortex <- FindNeighbors(cortex, reduction = "pca.cortex.sketch", dims = 1:50) cortex <- FindClusters(cortex, cluster.name = "seurat_cluster.sketched") cortex <- RunUMAP(cortex, reduction = "pca.cortex.sketch", reduction.name = "umap.cortex.sketch", return.model = T, dims = 1:50, verbose = T) DimPlot(cortex, label = T) # create the RCTD query object using 'SpatialRNA' function counts_hd <- cortex[["sketch"]]$counts cortex_cells_hd <- colnames(cortex[["sketch"]]) coords <- GetTissueCoordinates(cortex)[cortex_cells_hd, 1:2] query <- SpatialRNA(coords, counts_hd, colSums(counts_hd)) ### load in a scRNA-seq reference dataset ref <- readRDS("../Seurat/Visium_HD/allen_scRNAseq_ref.Rds") counts <- ref[["RNA"]]$counts view(ref@meta.data) cluster <- as.factor(ref$subclass_label) levels(cluster) <- gsub("/", "-", levels(cluster)) # cluster <- droplevels(cluster) nUMI <- ref$nCount_RNA # create the RCTD reference object reference <- Reference(counts, cluster, nUMI) # Creating RCTD Object RCTD <- create.RCTD(query, reference, max_cores = 8) # max_cores: for parallel processing. # run RCTD RCTD <- run.RCTD(RCTD, doublet_mode = "doublet") # add results back to Seurat object cortex <- AddMetaData(cortex, metadata = RCTD@results$results_df) view(cortex@meta.data) DimPlot(cortex, label = T) DimPlot(cortex, group.by = "first_type", label = T) # change NA to Unknown cortex$first_type <- as.character(cortex$first_type) cortex$first_type[is.na(cortex$first_type)] <- "Unknown" DimPlot(cortex, group.by = "first_type", label = T) # project RCTD labels from sketched cortical cells to all cortical cells cortex <- ProjectData(object = cortex, assay = "Spatial.008um", full.reduction = "pca.cortex", sketched.assay = "sketch", sketched.reduction = "pca.cortex.sketch", umap.model = "umap.cortex.sketch", dims = 1:50, refdata = list(full_first_type = "first_type")) DefaultAssay(cortex) <- "Spatial.008um" view(cortex@meta.data) DimPlot(cortex, label = T, group.by = "full_first_type") SpatialDimPlot(cortex, group.by = "full_first_type", label = T, repel = T, label.size = 4)

  • @Icywings-v1b
    @Icywings-v1b 3 месяца назад

    professor, can u help me with this Integrating data Warning: Layer counts isn't present in the assay object; returning NULL Merging dataset 5 4 into 6 Extracting anchors for merged samples Finding integration vectors Error: std::bad_alloc

    • @Collection_of_online_tutorials
      @Collection_of_online_tutorials 3 месяца назад

      You can watch the seurat V5 videos for data integration

    • @Icywings-v1b
      @Icywings-v1b 3 месяца назад

      @@Collection_of_online_tutorials Using rpca instead of pca, l'm getting 15 clusters instead of 14( integrating NML and IPF )and also cell ident is different from yours.ls that normal?

    • @Collection_of_online_tutorials
      @Collection_of_online_tutorials 3 месяца назад

      @@Icywings-v1b it is normal

  • @sivasankarchandran8532
    @sivasankarchandran8532 3 месяца назад

    Very useful work sir. Continue doing it.

  • @Icywings-v1b
    @Icywings-v1b 3 месяца назад

    Professor,how do we get only 2 plot- control and IPF,I'm getting 6 of them