Abstract
The primary motor cortex (M1), a conserved structure in the mammalian brain, governs voluntary muscle movement. However, molecular-level differences between human and chimpanzee cell types remain poorly understood. A cross-species analysis could uncover specific cell types and gene developments aligned with motor skill evolution. This study analyzed single-nucleus RNA sequencing (snRNA-seq) data of more than 235,000 nuclei from human, chimpanzee, and rat samples. It utilized state-of-the-art machine learning techniques along with an innovative uncertainty-aware label transfer approach, facilitating the discovery of potentially human-specific cell types and more refined definitions of cell subclasses. Together with non-neuronal cells, this comparison across species revealed established excitatory and inhibitory neuronal populations, therefore identifying more than 50 different glutamatergic cell types. Excitatory neurons accounted for 60–65% of cells in humans and chimpanzees, compared to 70–75% in rats. This observation underscores the differences in cortical organization across species. This work discovered a small population of L4-like excitatory neurons in primates that express RORB, linking the transcriptomic profiles of layer 3 and layer 5. Should these L4-like cells be confirmed histologically, they may significantly contribute to corticothalamic and thalamocortical communication, providing valuable insights into the evolutionary complexity of the motor cortex. Finally, a group of human specific excitatory cell types exhibited unique gene expression patterns linked to neurodevelopmental disorders, including ADHD and autism. This indicates that these conditions may be unique to humans.
Introduction
Single Nucleus RNA Sequencing (snRNA-seq), is revolutionizing tissue mapping by giving precise RNA reads of hundreds of thousands of single nuclei in a tissue sample. Previous studies leveraging single-nucleus RNA sequencing have demonstrated its utility in uncovering neuronal subtypes and transcriptomic diversity in human cortical regions, paving the way for identifying orthologous neuronal populations and their specific gene expression profiles across species1.
The primary motor cortex (M1) is one of the major brain areas responsible for controlling and learning skilled voluntary movement2’3’4. Human M1 is organized topographically, each body part has a corresponding representation location on the cortex, and the cortex itself is composed of six layers of neurons. Two main neuronal populations, GABAergic inhibitory neurons and glutamatergic excitatory neurons, were observed in M1. Interestingly, a species-specific adaptation of the proportions of neuron types and gene expressions were detected among humans, mice, and marmosets5. To explore the evolutionary conservation and divergence of M1 cell types and their transcriptomes, this study used snRNA-seq to analyze M1 cortices of humans, chimpanzees, and rats. In addition, this analysis utilized a novel uncertainty-aware cell type label transfer method to uncover potential unique cell types by cross species annotation. By comparing human data to chimpanzee data, the most closely genetically related animals to humans6 , it will help identify uniquely human genetic features including disorders and diseases.
This analysis focused on excitatory neurons and identified over 50 excitatory (Exc), or glutamatergic (Glut) cell types across humans, chimpanzees, and rats. Hierarchical cell labeling was used in the paper, from cell classes, e.g., GABAergic, Glutamatergic, and non-neuronal, and cell subclasses, like “Vip, Sst”, to individual cell types, e.g., “L5_IT_0”. There were significant differences in the proportions of excitatory cells, with the rat samples exhibiting approximately 70–75% excitatory neurons, with chimpanzees and humans closer to 60–65%. Furthermore, as excitatory neurons move up the vertical layers of the motor cortex, they become less conserved across species. For example, a chimpanzee layer two (L2) neuron shares more marker genes with a human L2 neuron than a chimpanzee layer six neuron (L6) with a human L6. This pattern is not observed in inhibitory neurons, which remain overall much more tightly conserved across all species. The analysis of primate excitatory neurons in this study suggests the potential existence of layer 4-like (L4-like) excitatory neurons in primates. The motor cortex has traditionally been described as ‘agranular’ or ‘disgranular,’ implying a less prominent L4 (Shipp et al., 2013). However, recent functional investigations suggest that M1 contains a circuit-level equivalent of L4 in the mouse7. We identified clusters of neurons sharing marker genes with both L3 and L5 cells, and clustering algorithms often struggled to split these clusters. Changing the clustering organization to account for cross layer neurons yielded distinct clusters between L3 and L5. CellChat8 and synaptic gene ontology analysis of differentially expressed genes within these clusters revealed unique cell communication pathways and patterns within this cluster. In rodents, L4 cells communicate directly with the thalamus; a unique communication pathway compared to other M1 excitatory neuron layers9. Based on the communication pathway distinctness and transcriptomic similarity to L3 and L5, these cells appear to point towards further evidence of existence of L4-like cells within primates.
Finally, the gene ontology analysis of human-specific cell types revealed the presence of pathways associated with autism and ADHD. Clinical diagnoses of autism and ADHD are currently restricted to humans, though certain animal models exhibit behaviors that resemble aspects of these conditions (Patterson, 2011). Consequently, it remains unclear to what degree these behaviors in animals share the same neurobiological underpinnings as human autism or ADHD.
Methods
Data collection
The 10X single nucleus RNA-sequencing data was downloaded from the Brain Initiative Cell Census Network (BICCN)10, for chimpanzees (https://assets.nemoarchive.org/dat-depxfwd), rats (https://assets.nemoarchive.org/dat-yio1gaw), and the human data is a CV3 snRNA-sequencing data previously published11 also sourced from BICCN. Gene annotation and genome sequences were collected from Ensembl release 111 (Rat: https://ftp.ensembl.org/pub/release-111/gtf/rattus_norvegicus/Rattus_norvegicus.mRatBN7.2.111.chr.gtf.gz, Human: https://ftp.ensembl.org/pub/release-111/gtf/homo_sapiens/Homo_sapiens.GRCh38.111.chr.gtf.gz , and Chimpanzee: https://ftp.ensembl.org/pub/release-111/gtf/pan_troglodytes/Pan_troglodytes.Pan_tro_3.0.111.chr.gtf.gz). 10x Genomics Cell Ranger v7.2.0 was used to map the raw sequencing files to the corresponding genome and transcriptome, filter the low-quality reads, and generate the cell x gene read count matrix.
Quality control and preprocessing of snRNA data
Scanpy package was used to preprocess the cell by gene read matrices12. Cells which expressed more than 5% ribosomal or mitochondrial genes were removed, as high mitochondrial or ribosomal gene counts are indicative of unhealthy or abnormal cells. Cells expressing fewer than 500 genes (non-neuronal) or 1,000 genes (neuronal) and cells with over 10,000 genes were excluded. Genes with non-zero counts are considered as detected. In addition, XY chromosome genes and genes expressed in less than three cells were removed. Suspected doublets were removed with the Scrublet package13. Clustering identified doublet cutoff scores for ambiguous samples. The maximum sublet score was 0.3.
Initial clustering was conducted on the filtered cell by gene matrices. Cell read counts were normalized and log transformed. The top 2000 highly variable genes were selected using seurat_v3 then scaled to unit variance and centered. Principal component analysis (PCA) was conducted to reduce dimensions. The data was fed into the Harmony package to remove batch effects.
Clustering
The batch corrected cell by gene matrix using the top 30 principal components was used to generate a nearest neighbor graph and the leiden community detection algorithm was applied to find clusters. Clusters were evaluated against quality control criteria. Firstly, the clusters were evaluated with their silhouette score and Calinski-Harabasz Index to measure the effectiveness of clustering parameters. With the clustering parameters set, the final clusters were filtered if it has a high percentage of mitochondrial or ribosomal gene expression, or high doublet score. No sample-specific clusters were detected, confirming the effectiveness of batch effect removal. Clusters were merged and categorized into three classes, GABAergic, Glutamatergic, and non-neuronal, based on the expression level of marker genes associated with these cell classes. There are no defined marker genes for chimpanzees and rats in the literature, so homologous marker genes from humans and mice respectively were applied (Bakken et al., 2021). The assumption is that the three broad cell classes are well conserved between such closely related species so there would be much overlap with marker genes. The human marker genes GAD1, SLC17A7, SV2B, and ST18 were effective for clustering chimpanzee data, and same for the mouse maker genes Gad1, Sv2b, Qki on rats. Despite this, the chimpanzee’s data retained clusters that did not show a clear expression of any above human marker genes. A Wilcoxon test of these clusters of interest against the rest of the dataset revealed genes that are specifically expressed in these clusters. The Wilcoxon Rank-Sum Test is a non-parametric test that is used to compare two independent samples to determine whether their population mean ranks differ. This test is robust to outliers and skewed distribution. Based on the known expression specificity of the top genes, these clusters were grouped into one of the three classes. After all clusters were either filtered or grouped, the distribution and the average of the number of genes expressed in each cell class were calculated.
The same clustering procedure was applied to each cell class separately for both chimpanzees and rats. Evaluation of clustering metrics using silhouette score and Calinski-Harabasz Index determined that a resolution of 1.0 on leiden yielded better defined clusters (Figure 1).

A hierarchical clustering approach was applied to the leiden clusters on the selected top 50 PCs. The leiden clusters that clustered together were grouped into cell subclasses and annotated according to the expression of the homolog genes of published human and mouse cell subclass marker genes. However, there were once again clusters that did not show clear expression of known human or mouse markers. The top 20 genes selected by the Wilcoxon test of the leiden clusters were evaluated to refine markers for chimpanzee and rat cell subclasses. After subclasses were defined, every leiden cluster within a subclass was considered a cell type. Unlike subclasses, cell types are not universally agreed upon, but they represent the finest degree of separation possible with current techniques14. Cell types with less than 40 cells were ignored. Only clusters which reappeared during rounds of re-clustering at different resolutions were accepted as cell types.
Cross-species integration
To identify conserved and divergent cell subclasses and cell types across species, the individually clustered datasets for each animal were integrated into a large matrix retaining the cluster labels of each species. To maintain acceptable computing speed, the dataset was split into three, where each dataset represented one cell class. The integration and clustering were conducted on both cell class and subclass levels. Orthologous genes were obtained from Ensembl 111 release15. Genes with one-to-one orthologs in each pair of the three species were selected for integration. The number of cells after QC filtering were similar between species (~50,000 cells each). The raw counts were normalized and log transformed using the same approach as processing each species separately. The package Harmony was used for cross species integration on the cell class level16. Harmony can simultaneously account for batch effects of multiple datasets and biological factors. It starts with an initial PCA embedding and clusters the cells into multiple groups, penalizing those with low diversity. For each cluster, both a cluster centroid and dataset-specific centroids are calculated. Correction factors are determined by comparing the dataset centroids to the cluster centroid. Each cell is then corrected using a linear combination of the dataset correction factors, weighted by the clustering. This process repeats until convergence. At convergence, cells are corrected and assigned to clusters that correspond to cell classes or types rather than dataset-specific conditions. Default parameters proposed by the package were applied in this analysis. The “seurat_v3” approach was used to select 1,500 highly variable genes from the integrated data. After harmony correction of the top 50 principal components, the nearest neighbor graph was generated, and cells were clustered using the same leiden clustering approach implemented in the Scanpy package with resolution 0.1. A low resolution was applied to get a coarse clustering at the cell class level. Clusters with low quality, e.g., high mitochondrial or ribosomal expressions were removed. The composition of three species in each leiden cluster were calculated and identified rat and chimpanzee specific clusters and primate specific clusters. Previously identified cell class marker genes of each species were examined and used to annotate clusters into three cell classes. The cell proportion of each cell class in the integration results were calculated.
GABAergic cells are very well conserved across all three species, leaving little room for analysis, but glutamatergic cells had the most variation. The scVI17 and scANVI18 packages on the glutamatergic cells aided studying the conserveness and divergence of glutamatergic cells across species. scVI provided a probabilistic representation of gene expression in each cell, while scANVI aided cell type annotation and matching cell types across species. scANVI is a semi-supervised approach that builds up on the scVI model. The subclass annotations obtained from clustering were used to evaluate the consistency of subclasses between species to identify conserved and species-specific subclasses. All three species were integrated and examined, but there was a specific focus on primate specific analysis. The label conservation metrics, KMeans (Normalized mutual information) NMI and Adjusted Rand Index (ARI), were used to assess the overall conservedness of clusters overlaps across species. A leiden algorithm was applied on the nearest neighbor graph created on the scANVI derived latent space. The three species clustering was visualized using Uniform manifold approximation and projection (UMAP), and cluster overlaps were measured by NMI and ARI. Many rat specific clusters were observed and clearly separated from primates, and human and chimpanzees were mixed well. (add metric measured values, histogram of cell composition of each cluster).
Human and chimpanzee glutamatergic cells were separated and processed using scANVI. The cross-species subclass annotation of each cluster was derived based on the subclass labels that fit most of the cluster. Most clusters have well mixed cells from both species, and mostly consist of cells from a single subclass (> 90%) which indicates strong conservation between species. Notably, a few clusters had high representation of cells from both L2_L3_IT and L5_IT, where each subclass represented greater than 30% of the cluster. These clusters were annotated as the L3_L5_IT subclass, which represented cells between the two layers, which also included L4-like cells. The UMAP of clusters were color coded by species for visualization, and cross species subclass annotations were generated using scANVI generated latent space representation. The composition of species subclass labels in each cross-species subclass were visualized. All cross-species results clustering had > 98% matching with the individual species clustering, except for the L3_L5_IT subclass. It is composed of 27% of L5_IT cells and 72% of L2_L3_IT cells. This is due to L3_5_IT not existing within individual species clustering, but when integrated, it clearly separated out from other preexisting subclasses.
Differential Gene Expression Analysis
For future categorization of cells, the defining genes for each subclass and cell type were compiled and compared to the previous analysis on human data14, such that cell types and subclasses could be mapped consistently and compared across species. This step was important for integration, as the human data came from a different source than the rat and chimpanzee data. The paper it came from already clustered the raw data into subclasses and cell types. To identify each subclass and cell type, differentially expressed genes (DEGs) were cataloged using a one-to-all comparison. DEG analysis was applied using the R package limmatrend_cov, which accepted raw cells by gene matrices19. Trimmed mean of the M-values (TMM) normalization log transformation to counts per million were used to normalize the limmatrend_cov results. TMM is a normalization method that estimates normalization factors by using a weighted trimmed average of log fold changes. It utilizes precision weights (the inverse of variance) to account for the fact that log fold changes derived from genes with higher read counts exhibit lower variance on the logarithmic scale. The batch information was also added to the design matrix as a confounding factor. A lack of validation techniques meant that it would be impossible to accurately tune the DEG cutoff. Since DEG was utilized to find a smaller number of defining genes for each cell type or subclass, a more stringent cutoff of log fold change > 1.2 and adj p-value < 0.05 were used to identify candidates from the DEG list.
Cell Type Annotation
The visualization of clusters generated from the scANVI model of primate data shows that the conservation in glutamatergic cell types between species is not clear. To compound matters, with the same cutoffs and procedure to find marker genes, some cell types lacked marker genes that matched those cutoffs. Since human cell types were far more published and annotated than the other species, those human annotations were used to classify the chimpanzee data. However, due to the granularity of cell class level clustering, there could be some significant gaps in this approach with species specific clusters. Extreme gradient boosting (XGboost)20. XGboost uses a set of gradient boosted decision trees where weights of features/genes contributed to each class allow for automated identification of the marker genes. Furthermore, the regularized model and sparsity aware algorithm makes XGboost resistant to overfitting and missing data to a degree21. Hyperparameters for XGboost were tuned by splitting the human data into training and testing sets and finding a set of parameters that produced the best results. The resulting set of hyperparameters used in the analysis is {‘eta’: 0.2, ‘max_depth’: 6, ‘subsample’: 0.5, ‘colsample_bytree’: 0.5, ‘eval_metric’: ‘mirror’, ‘seed’: 840}.
Applying devCellPy using known cell type annotations on human glutamatergic data with known cell type annotations created a custom classification model. This model was used to classify the chimpanzee’s data. 10-fold cross validation was used in model training and cells classified with <50% certainty was annotated as “unclassified”. Unclassified cells were considered either chimpanzee specific cell types or poorly annotated cells and evaluated by gene ontology analysis downstream. To find a list of predictor genes for cell type clustering, devCellpy’s incorporated SHAP algorithm ranked the top positive predictor genes.
Gene ontology and cell interaction analysis
The gene expression profiles of each cell subclass and cell types produced by DEG analysis were investigated in gene ontology (GO) enrichment. The online resource gprofiler22 was used for GO analysis. gprofiler can validate marker genes if the genes map to neuron related pathways. Furthermore, gprofiler can grant a summary of a subclass function, and this was cross-referenced with existing papers to determine the validity of the subclasses. CellChat was used to infer major molecular interactions and signaling roles of human glutamatergic cells, based on highly expressed and differential genes. Specifically, it uses gene sets to predict likely ligand-receptor pairs and cofactors from a list of roughly 2200 human signaling molecule interactions contained in the CellChatDB. The cell by gene count matrix was normalized to 10000 reads per cell and log transformed. Overexpressed genes of each cell type were identified using the Wilcox test comparing one to all, with p-value < 0.005 and fold change greater than 1.2. The overexpressed signaling pathways were identified by examining the overlap between the overexpressed genes and the ligand-receptor pairs in the database. For each cell pair, 25% truncated average expression of ligands, receptors, and cofactors of the overexpressed signaling pathways were used to derive the communication probability using the hill function. 25% truncated average expression means that the average expression of a gene in a cell group is considered zero if less than 25% of cells in that group express the gene. The Hill function represents the fraction of a receptor bound by a ligand, as a function of the ligand concentration. A Hill coefficient of 1 and the dissociation constant of 0.5 were used. The probability was assigned zero if the p-value of a permutation test was greater than 0.05. The permutation test creates one hundred random permutations of the cell groups. The probability of ligand/receptor interactions between two cell groups are calculated and compared to these 100 permutations. The number of cases where the random permutations showed a higher probability was counted, and the ratio of these occurrences to the total number of permutations (100) are used as the p-value, representing the statistical significance of the communication probability. Within the inferred cell-cell communication network, the dominant interaction sender and receivers, as well as the contribution of signals in terms of outgoing and incoming were identified by calculating the weighted outdegree and weighted indegree of each interaction, producing an interaction summary for each cell type.
Results
Conserved transcriptomic cells cross specie
From the data collected in BICCN23 and previously published human M1 data14, more than 235,000 cells passed quality control with a roughly equal number of cells from each species (Table 1).
human | chimpanzee | rat | |
GABAergic | 23992 | 21987 | 11512 |
Glutamatergic | 48536 | 56322 | 56195 |
Non-neuronal | 4005 | 7413 | 5396 |
In the collection process, the cells were enriched for neurons, resulting in more than 90% of the population being neurons. Known markers were used to label cells into three broad classes, GABAergic, Glutamatergic, and Non-neuronal. After finding cell clusters with the markers GAD1 for GABAergic, and SATB2, SV2B, and SLC17A7 for glutamatergic cells, the resulting clusters showed more than twice the number of glutamatergic cells than GABAergic cells across all species, with the specific ratios: humans (67% vs. 33% ) to chimpanzees (72% vs. 28%) and rats (83% vs. 17%) (Figure 2 (a)). Non-neuronal cells have the lowest number of genes detected, on average about 2000 genes per cell for all three species. Glutamatergic cells have the greatest number of genes detected, ranging from 4000 to 6500 genes per cell, with rats having the least genes per cell while humans have the greatest. Overall, humans have more genes detected in all three classes, and chimpanzees and rats have a similar number of average genes detected in GABAergic and non-neuronal classes, but chimpanzees have more genes detected in glutamatergic cells than rats, with about 1000 more genes (Figure 2 (b)).
Subclasses were further identified by unsupervised clustering of cells exclusively assigned to each class. Figure 3(a-c) shows a uniform manifold approximation and projection (UMAP) of subclasses detected in each species separately. Every subclass contains cells from each donor. Cells of the same classes and subclasses were grouped together by the transcriptional profile across species (Figure 3(d)). Consistent with previously identified24 GABAergic cells can be grouped into two sets: Pvalb, Sst; Sst and Chold express ADARB2; and Vip, Lamp5, and Sncg express LHX6, while the proportion of cells expressing Lhx6 in rats is relatively low (Figure 3(d)). Non-neuronal markers are not as consistent as neuronal cells between rats and the others (humans and chimpanzees). No consensus marker was identified for non-neuronal cells of all three species. In addition, NCKAP5 marks OPC, Astrocytes, and Oligo cells for both humans and chimpanzees; and MBP and SLC1A3 together marks all non-neuronal cells except Endo/peri cells in humans. Humans and chimpanzees show similar GABAergic subclass proportions, with the exception of Vip cells. (Figure 4 (a)). Chimpanzees have significantly more Vip cells than both humans and rats. Rats have significantly more Pvalb cells but less Lamp5 cells than humans and chimpanzees. Glutamatergic cell subclass compositions tend to be more variable between species than GABAergic cells. Findings from single-cell transcriptomics suggest conserved gene expression markers among GABAergic neurons across mammalian species, reaffirming their evolutionary stability compared to the more divergent glutamatergic neuron populations (Lake et al., 2016). In humans and chimpanzees, over 35% of detected glutamatergic neurons belong to superficial layers (layers 2 and 3), unlike in rats. (Figure 4 (b)). On the other hand, L6 corticothalamic cells and L5 extra-telencephalic cells in primates are much rarer than in rats. Humans have more non-IT (intra-telencephalic) cells than chimpanzees overall, mostly L6 corticothalamic cells and L6b cells. Unlike GABAergic neurons which have similar compositions across species, compositional variation within Glutamatergic neurons is much greater.
Integrated GABAergic and Glutamatergic cells across three species separately reveal the transcriptomic conservedness and diversity of subclasses. Six GABAergic subclasses with well mixed cells across species were detected (Figure 5 (a)). Human and chimpanzee data have far more overlap with each other than with rat data (Figure 5 (b)). Comparing GABAergic and Glutamatergic neurons by clustering integrated cells using subclass labels revealed bio-conservedness of subclasses. Four clustering comparison metrics were calculated to evaluate the bio-conseveness: normalized mutual information (NMI), adjusted rand index (ARI), silhouette width, and isolated label (Table 2). With all metrics taken into account, GABAergic cells are more conserved than Glutamatergic cells between both mammals and primates.
Mammals | Primates | |||||
GABAergic | Glutamatergic | GABAergic | Glutamatergic | |||
NMI | 0.76 | 0.68 | 0.85 | 0.83 | ||
ARI | 0.61 | 0.47 | 0.62 | 0.41 | ||
Silhouette width | 0.64 | 0.65 | 0.63 | 0.67 | ||
Isolated label | 0.8 | 0.74 | 0.71 | 0.86 | ||
Average | 0.703 | 0.635 | 0.755 | 0.64 |
Glutamatergic neuron conserveness and diversity
Markers of glutamatergic cells are well conserved across species (Figure 6 (a)). Nine Glutamatergic subclasses with well mixed cells across species were detected. Integrated clustering of human and chimpanzee glutamatergic cells show a well-mixed cross species and clear separation between subclasses (Figure 6 (b)). CUX2 is distinguishably highly expressed in more than 80% of L2/3 IT cells of all three species. The clusters that over-express RORB (known L4 marker in the mouse M1)25 and under express L2/3 IT and L5 IT markers are annotated as L3/5 IT, potentially containing L4 IT neurons. The new subclass L3/5 IT was separated from L2/3 IT and L5 IT cells and highlighted in orange (Figure 6 (b)). It is composed of cells originally grouped into L2/3 IT and L5 IT. High CUX2 expression combined with low expression of RORB can distinguish L2/3 IT cells from L3/5 IT cells. Both L3/5 IT cells and L5 IT cells express high levels of RORB in >80% of cells, but L3/5 IT are differentiated from L5 IT cells, by L3/5’s low expression of IL1RAPL2. High ADAMTS3 and THEMIS expressions mark L6 IT and L6 IT Car3 cells in humans and chimpanzees. L6 IT Car3 cells are differentiated from L6 IT cells by their high expression of HS3ST4. Finally, there is a large difference in marker genes for L6b, as MDFIC and SEMA3D together are markers for primate L6b cells, whereas the rat L6b marker is CCN2. In differentiating layer five glutamatergic cells, L5 ET cells are distinguished by high expression of both TAFA1 and BCL11B. TSHZ2 and NXPH (neurexophilin family) mark L5 NP cells, although there is slight variation in species as rats express NXPH1 while primates express NXPH2. Surprisingly, FEZF2, a previously identified marker for L5 neurons, was not uniquely expressed in any cell subclass. FOXP2 is known to be down-expressed in non IT cells in mice, also expressed in human and chimpanzee L5 IT cells. Table 3 summarized Glutamatergic subclass marker genes conserved between humans and chimpanzees.
Each subclass had a different number of conserved marker genes between species, ranging from eight to 57 markers. Far more conserved markers (>27%) were detected between humans and chimpanzees than between either primate and rat in all seven subclasses (Figure 6 (c)). However, many markers had high expression in only one species. Non-IT cells tend to have more differentially expressed genes than IT cells (Figure 6 (c-d)).
To evaluate the magnitude of difference in gene expression patterns between primates, five distance metrics, spearman distance, mean absolute error, Euclidean distance, mean squared error, and Pearson distance were calculated between the centroids of human subclasses and chimpanzee subclasses. L6 corticothalamic cells have the lowest overall distance, followed by L5/6 near projecting cells, and L6b cells. Among the intra telencephalic cells, L3/5 IT and L6 IT have the lowest distance and are followed by L5 IT and L2/3 IT. L2/3 IT and L6 IT Car3 cells have the largest distance overall between species. Besides this broad trend conserveness varies more between cell subclasses than physical locations (layers) (Figure 6 (e)).
35 cell types were detected in chimpanzees with higher resolution clustering, and mostly aligned with previously annotated26 44 human cell types (Figure 6 (f)). Hierarchical clustering of the cell types illustrated this alignment as cell types under the same subclass clustered tightly together regardless of species. However, the number of cell types detected within each subclass varies between humans and chimpanzees. The small clusters under a subclass tree, formed by single species cells indicate species specific cell types.
Glutamatergic Cell Subclass | Genes conserved between humans and chimpanzees |
L2/3 IT | CUX2 |
L3/5 IT | CUX2, RORB |
L5 IT | RORB, IL1RAPL2 |
L6 IT | ADAMTS3, THEMIS |
L6 IT Car3 | ADAMTS3, THEMIS, HS3ST4 |
L6b | MDFIC, SEMA3D |
L5 ET | TAFA1, BCL11B |
L5 NP | TSHZ2, NXPH2 |
Layer four neurons
Further high-resolution unsupervised clustering was applied to intratelencephalic cells from the integrated snRNA-seq data to identify potential L4 IT cells. Clusters were labeled with the expression pattern of known markers from humans and mice. Rat L4 cells cluster out cleanly, so clusters with an over-expression of layer four marker (RORB) were separated and annotated as L4 IT cells (Figure 7 (a)). However, there was less clear separation of human and chimpanzee L4 IT cells from L2/3 IT and L5 IT cells. Less than 100 human and chimpanzee cells were clustered with the rat L4 IT cluster. Therefore, the clusters that express both RORB and L2/3 markers were designated as L3/4 IT cells, as most of L2/3 IT did not express RORB (Figure 7 (c)), and those that expressed RORB and L5 markers were designated as L4/5 IT cells (Figure 7 (a)). L2/3 IT, L3/4 IT, and L4 IT cells have high expression of CUX2, with strong presence in > 80% of the population. L4 IT had the strongest expression of RORB and L3/4 IT had the lowest expression level among L3/4 IT, L4 IT, and L4/5 IT (Figure 7 (c)). L3/4 IT and L4 IT have a high expression of GRM3, but L4/5 IT expresses GRM1 instead. Both GRM1 and GRM3 belong to the GRM gene family that are associated with the glutamatergic receptor complex. On the other hand, PLCH1 and TSHZ2 are exclusively highly expressed in L3/4 IT and L4/5 IT respectively.
Previous studies show that cell types may cross layers27 , so the accepted division of subclasses into layers may limit the understanding of cell types in finer resolution. It is known that RORB is expressed in the bottom of layer three and upper part of layer five28. Any potential L4 IT cells should be contained in the L3/4 IT and L4/5 IT clusters. The separation of L4-like IT cells (consisting of the primate exclusive L3/4 IT and L4/5 IT cells) from L2/3 IT and L5 IT was evaluated using the centroid distance between clusters in the principal component space (Figure 7 (b)). The centroid distances in the space of the first five principal components provides more evidence for L4-like IT cells as the L4-like IT cell centroid is closer to L2/3 IT and L5 IT than they are to each other. The blurring of subclasses also indicates that cell types often cross between layer three and layer five.
The number of L4-like IT cells is less than half the number of L2/3 IT or L5 IT cells. In L4-like IT cells, 209 DEGs were detected (Figure 7 (d-e)) by pairwise differential expression analysis. About 40% and 24% of L4-like IT DEGs overlap with L5 IT and L2/3 IT DEGs respectively. Synaptic gene ontology29 analysis of these DEGs show that L4-like IT cells are more enriched in the presynaptic component and process, while L2/3 IT cells contribute more to the postsynaptic component and process (Figure 7 (f-g)). It is consistent with the previous knowledge that layer 4 receives signals from the thalamus and passes to superficial layers, like layer two and three30. L5 IT cells are equally enriched in both pre and post synaptic processes, with less statistical significance than L2/3 IT and L4-like IT cells. A few biological processes and cellular components were identified as enriched in L4-like IT cells only, like presynaptic processes involved in chemical synaptic transmission.
We identified human specific cell types by using the transcriptomic pattern of human cell types to label chimpanzee cells (Figure 8 (a)). If a human cell type that labels less than 40 chimpanzee cells and the number of labeled chimpanzee cells are less than 10% of the human cell type size, it is determined as a human specific candidate. And the candidate cell types were further filtered by using chimpanzee cell types as classifiers to label human cells. If the candidate cells were labeled ‘undefined’, i.e., there are no chimpanzee cell types that have close transcriptomic pattern as the human cell type, then the human cell type was identified as potentially human specific. Four cell types in L6b, four cell types in L5 IT, five cell types in L6 CT, two cell types in L5 ET, one cell type in L6 IT Car3, one cell type in L2/3 IT, and one cell type in L5/6 NP were identified as human specific. Notably, while most human specific cell types were a few hundred cells large, one L5 IT cell type and one L2/3 IT cell type had more than 1000 cells (Figure 8 (b)). Enriched synaptic cellular components and the biological processes of the overexpressed genes in the human specific cell types were defined using synaptic gene ontology. These genes are mostly enriched in presynaptic and postsynaptic membranes, corresponding to organizational, presynaptic, and postsynaptic process functions (Figure 8 (c)). Furthermore, gene ontology with a focus on genetic disease and disorder pathways revealed that DEGs from human specific cell types had significantly higher expression of genes in pathways associated with autism and ADHD (Figure 8 (d)) compared to an average cell. Twenty-eight signaling pathways in the CellChat database31 were enriched by the human-specific cell types, either as the signal sender or receiver (Figure 8 (e)). Cell types of different subclasses were enriched in distinct pathways. The human-specific L2/3 IT cell type acts as a main signal sender in the PACP-PAC1 receptor pathways. Pituitary adenylate cyclase-activating polypeptide (PACAP) is known to broadly regulate the cellular stress response. A recent study shows that the PACAP-PAC1 receptor pathway plays a role in human psychological stress responses, such as post-traumatic stress disorder (PTSD). The two L5/6 ET cells were enriched in the pathway of cell adhesion molecules. It is known that cell-cell adhesions are important for brain morphology and underpin axon-axon contacts, linking neurons with supporting Schwann cells and oligodendrocytes.
Discussion
Summary
This analysis focused on excitatory neurons and identified over 50 excitatory, or glutamatergic(glut) cell types across humans, chimpanzees, and rats. There were also significant differences in the proportions of excitatory cells, with the rat sample being approximately 75% excitatory, chimp being 65%, and human being about 65% as well. Furthermore, as excitatory neurons move up the vertical layers of the motor cortex, they become less conserved across species. The analysis of primate excitatory neurons in this study points to the potential existence of layer four-like (L4-like) excitatory neurons in primates. L4 neurons are known to be found in rats but are predominantly believed not to exist in primates. Gene ontology analysis of human-specific cell types showed enrichment of certain genes previously linked to neurodevelopmental disorders, including autism and ADHD. However, gene ontology annotations are correlative, and follow-up functional studies would be needed to establish the roles these genes or pathways might play in such disorders.
Evidence of L4-like excitatory neurons in primates
Much of the analysis of primate excitatory neurons in this study points to the potential existence of layer 4-like (L4-like) excitatory neurons in primates. Analysis of primate excitatory neurons in this study found clusters of neurons that shared marker genes with both L3 and L5 cells, and clustering algorithms often struggled to split these clusters. In addition, RORB, a marker for L4 cells in rats, are overexpressed within the cells between L3 and L5. This points to a gray zone of unclassified neurons between L3 and L5, and the presence of L4 markers suggests some cells with similarity to L4 cells may be present within this gray zone. Furthermore, a comparison of centroids of L3, L5, and L4-like neurons showed that the L4-like neurons appear to be a transcriptomic mix of L3 and L5 neurons. However, the DEG analysis of L4-like neurons shows that despite their relations to L3 and L5 neurons, L4-like cells express a unique set of marker genes. The L4-like neurons likely represent a subclass distinct from L3 and L5, despite retaining some similarities in gene expression. Furthermore, this unique subclass appears to have many transcriptomic similarities with known L4 cells. Looking at synaptic gene ontology, the L4-like cells tend to have more presynaptic structures as well as a couple unique presynaptic processes, whereas L2/3 neurons are predominantly postsynaptic. This pattern aligns with the established function of L4 cells, which transmit signals from the thalamus to L2/3 in the motor cortex.
ADHD and Autism associated pathways in human-specific cells
Gene ontology analysis of human-specific cell types compared with shared cell types revealed the overexpression of genes implicated in pathways associated with autism and ADHD. Notably, the involvement of the frontal cortex in neurodevelopmental disorders such as autism has been linked to early postnatal overgrowth, further supporting the idea that human-specific pathways in the motor cortex may underlie distinct neurodevelopmental trajectories32. Genetic studies of ADHD highlight differential heritability estimates and unique genomic associations in adult populations, reflecting the complex interplay between conserved and species-specific pathways observed in primate motor cortex neurons33. Admittedly these results are preliminary and speculative, especially as the genetic causes for autism and ADHD are not fully understood34’35. If these results were to be validated, it would provide more evidence for the idea that autism and ADHD are human specific conditions. While autism and ADHD have not been diagnosed in animals other than humans, there are behavioral patterns with similar symptoms to autism in dogs36. Despite observation of autism-like behaviors in these animals, these findings suggest that those behaviors may not be genetically related to autism.
Trends in glutamatergic and GABAergic conserveness across species
The literature has established general trends in evolutionary conserveness between glutamatergic and GABAergic neurons, as well as within the layers of glutamatergic neurons. Firstly, it is known that across the evolution of mammals, L2 neurons grew the most, which means that the L2 layer should be least conserved37. This study found the same results, as L2 neurons had the farthest centroid distance between species for any glutamatergic subclass. In addition, comparing marker gene overlap, L5 and most L6 subclasses had greater overlap between species than L2/3 giving further evidence that L2 is less conserved than other subclasses. The second general conclusion is that GABAergic neurons are more conserved than glutamatergic neurons, which is also supported by pre-existing literature38. GABAergic neurons had notably higher bio-conservedness metrics than glutamatergic neurons, reinforcing the idea that they are more conserved. Furthermore, each subclass in GABAergic neurons can be clustered using the same marker genes for each species, whereas glutamatergic neurons require different marker genes for some rat subclasses than primate subclasses. This also shows that the subclasses of GABAergic neurons are more closely related across species than glutamatergic subclasses. These trends are important to the validation of the methods used, as many are very recent39, so the fact they display trends consistent with previous research is a strong indication of the validity of the techniques.
Limitations
This study was fundamentally limited by the inability to verify results with wet lab work. The data analysis conclusions require experimental verification. In addition, the study could not collect more data than what was already available on BICCN. A significant evolutionary gap exists between the target species, complicating direct comparisons. While chimpanzees and humans are closely related, there exists an evolutionary chasm between those two species and rats. As a result, the results lack nuance; for certain subclasses, there is almost nothing conserved between primates and rats. However, without more intermediate species, it’s impossible to tell if that subclass is primate specific or not. This study only focused on protein coding genes, using data enriched for protein coding RNA. Non-coding RNA plays significant roles in epigenetic control and cellular function40. In addition, due to limited resources, there is no experimental validation for the putative L4-like neurons and their marker genes.
Future work
Future studies should verify these patterns experimentally and broaden the scope of analysis. In addition, spatial scRNAseq data would contextualize these findings within neuron circuits. It could also augment the transcriptomic evidence for L4 neurons in the primate M1, by locating the cells that express marker genes for L4 neurons. Another direction for future work could be similar analysis presented in this research, on a greater number of species. There is a massive evolutionary void between primates and rats, and similar analysis of a better representation of the class Mammalia could potentially reveal a greater number of genetic pathways as they changed throughout evolutionary history.
Finally, access to greater computational power could increase the amount of data available. Although the roughly 250,000 cells in this study are standard for the technology, there still were several cell types that were thrown out on account of having too few cells to perform meaningful analysis. With many more cells, some of these smaller cell types could potentially be validated and analyzed.
References
- Lake, B. B., Ai, R., Kaeser, G. E., Salathia, N. S., Yung, Y. C., Liu, R., Wildberg, A., Gao, D., Fung, H.-L., Chen, S., Vijayaraghavan, R., Wong, J., Chen, A., Sheng, X., Kaper, F., Shen, R., Ronaghi, M., Fan, J.-B., Wang, W., … Zhang, K. Neuronal subtypes and diversity revealed by single-nucleus RNA sequencing of the human brain. Science (New York, N.Y.), 352(6293), 1586–1590 [↩]
- Ebbesen, C. L., & Brecht, M. Motor cortex—To act or not to act? Nature Reviews Neuroscience, 18(11), 694–705 (2017) [↩]
- Cousineau, J., Plateau, V., Baufreton, J., & Bon-Jégo, M. L. Dopaminergic modulation of primary motor cortex: From cellular and synaptic mechanisms underlying motor learning to cognitive symptoms in Parkinson’s disease. Neurobiology of Disease, 167, 105674 (2022) [↩]
- Burciu, R. G., & Vaillancourt, D. E. (2018). Imaging of Motor Cortex Physiology in Parkinson’s Disease. Movement Disorders, 33(11), 1688–1699 [↩]
- Bakken, T. E., Jorstad, N. L., Hu, Q., Lake, B. B., Tian, W., Kalmbach, B. E., Crow, M., Hodge, R. D., Krienen, F. M., Sorensen, S. A., Eggermont, J., Yao, Z., Aevermann, B. D., Aldridge, A. I., Bartlett, A., Bertagnolli, D., Casper, T., Castanon, R. G., Crichton, K., … Lein, E. S. (2021). Comparative cellular analysis of motor cortex in human, marmoset and mouse. Nature, 598(7879), 111–119 [↩]
- Sakate, R., Osada, N., Hida, M., Sugano, S., Hayasaka, I., Shimohira, N., Yanagi, S., Suto, Y., Hashimoto, K., & Hirai, M. (2003). Analysis of 5′-End Sequences of Chimpanzee cDNAs. Genome Research, 13(5), 1022–1026 [↩]
- Yamawaki, N., Borges, K., Suter, B. A., Harris, K. D., & Shepherd, G. M. G. (2014). A genuine layer 4 in motor cortex with prototypical synaptic circuit connectivity. eLife, 3, e05422; Yao, Z., Liu, H., Xie, F., Fischer, S., Adkins, R. S., Aldridge, A. I., Ament, S. A., Bartlett, A., Behrens, M. M., Van den Berge, K., Bertagnolli, D., de Bézieux, H. R., Biancalani, T., Booeshaghi, A. S., Bravo, H. C., Casper, T., Colantuoni, C., Crabtree, J., Creasy, H., … Mukamel, E. A. (2021). A transcriptomic and epigenomic cell atlas of the mouse primary motor cortex. Nature, 598(7879), 103–110 [↩]
- Patterson, P. H. (2011). Modeling autistic features in animals. Pediatric Research, 69 (5 Pt 2), 34R-40R [↩]
- Hawrylycz, M., Martone, M. E., Ascoli, G. A., Bjaalie, J. G., Dong, H.-W., Ghosh, S. S., Gillis, J., Hertzano, R., Haynor, D. R., Hof, P. R., Kim, Y., Lein, E., Liu, Y., Miller, J. A., Mitra, P. P., Mukamel, E., Ng, L., Osumi-Sutherland, D., Peng, H., … Zingg, B. (2023). A guide to the BRAIN Initiative Cell Census Network data ecosystem. PLoS Biology, 21(6), e3002133 [↩]
- Hawrylycz, M., Martone, M. E., Ascoli, G. A., Bjaalie, J. G., Dong, H.-W., Ghosh, S. S., Gillis, J., Hertzano, R., Haynor, D. R., Hof, P. R., Kim, Y., Lein, E., Liu, Y., Miller, J. A., Mitra, P. P., Mukamel, E., Ng, L., Osumi-Sutherland, D., Peng, H., … Zingg, B. (2023). A guide to the BRAIN Initiative Cell Census Network data ecosystem. PLoS Biology, 21(6), e3002133 [↩]
- Bakken, T. E., Jorstad, N. L., Hu, Q., Lake, B. B., Tian, W., Kalmbach, B. E., Crow, M., Hodge, R. D., Krienen, F. M., Sorensen, S. A., Eggermont, J., Yao, Z., Aevermann, B. D., Aldridge, A. I., Bartlett, A., Bertagnolli, D., Casper, T., Castanon, R. G., Crichton, K., … Lein, E. S. (2021). Comparative cellular analysis of motor cortex in human, marmoset and mouse. Nature, 598(7879), 111–1190 [↩]
- Wolf, F. A., Angerer, P., & Theis, F. J. (2018). SCANPY: large-scale single-cell gene expression data analysis. Genome Biology, 19(1), 15 [↩]
- Wolock, S. L., Lopez, R., & Klein, A. M. (2019). Scrublet: Computational Identification of Cell Doublets in Single-Cell Transcriptomic Data. Cell Systems, 8(4), 281-291.e9 [↩]
- Bakken, T. E., Jorstad, N. L., Hu, Q., Lake, B. B., Tian, W., Kalmbach, B. E., Crow, M., Hodge, R. D., Krienen, F. M., Sorensen, S. A., Eggermont, J., Yao, Z., Aevermann, B. D., Aldridge, A. I., Bartlett, A., Bertagnolli, D., Casper, T., Castanon, R. G., Crichton, K., … Lein, E. S. (2021). Comparative cellular analysis of motor cortex in human, marmoset and mouse. Nature, 598(7879), 111–119 [↩] [↩] [↩]
- Harrison, P. W., Amode, M. R., Austine-Orimoloye, O., Azov, A. G., Barba, M., Barnes, I., Becker, A., Bennett, R., Berry, A., Bhai, J., Bhurji, S. K., Boddu, S., Branco Lins, P. R., Brooks, L., Ramaraju, S. B., Campbell, L. I., Martinez, M. C., Charkhchi, M., Chougule, K., … Yates, A. D. (2023). Ensembl 2024. Nucleic Acids Research, 52(D1), D891–D899 [↩]
- Korsunsky, I., Millard, N., Fan, J., Slowikowski, K., Zhang, F., Wei, K., Baglaenko, Y., Brenner, M., Loh, P., & Raychaudhuri, S. (2019). Fast, sensitive and accurate integration of single-cell data with Harmony. Nature Methods, 16(12), 1289–1296 [↩]
- Gayoso, A., Lopez, R., Xing, G., Boyeau, P., Valiollah Pour Amiri, V., Hong, J., Wu, K., Jayasuriya, M., Mehlman, E., Langevin, M., Liu, Y., Samaran, J., Misrachi, G., Nazaret, A., Clivio, O., Xu, C., Ashuach, T., Gabitto, M., Lotfollahi, M., … Yosef, N. (2022). A Python library for probabilistic analysis of single-cell omics data. Nature Biotechnology, 40(2), 163–166 [↩]
- Xu, C., Lopez, R., Mehlman, E., Regier, J., Jordan, M. I., & Yosef, N. (2021). Probabilistic harmonization and annotation of single-cell transcriptomics data with deep generative models. Molecular Systems Biology, 17(1), e9620. [↩]
- Nguyen, H. C. T., Baik, B., Yoon, S., Park, T., & Nam, D. (2023). Benchmarking integration of single-cell differential expression. Nature Communications, 14(1), 1570 [↩]
- Chen, T., & Guestrin, C. (2016). XGBoost: A Scalable Tree Boosting System. Proceedings of the 22nd ACM SIGKDD International Conference on Knowledge Discovery and Data Mining, 785–794) is a well-known supervised machine learning method, and was adapted in cell annotations using the package devCellpy (( Galdos, F. X., Xu, S., Goodyer, W. R., Duan, L., Huang, Y. V., Lee, S., Zhu, H., Lee, C., Wei, N., Lee, D., & Wu, S. M. (2022). devCellPy is a machine learning-enabled pipeline for automated annotation of complex multilayered single-cell transcriptomic data. Nature Communications, 13(1), 5271 [↩]
- Saygili, G., & OzgodeYigin, B. (2023). Continual learning approaches for single cell RNA sequencing data. Scientific Reports, 13(1), 15286 [↩]
- Reimand, J., Kull, M., Peterson, H., Hansen, J., & Vilo, J. (2007). g:Profiler—A web-based toolset for functional profiling of gene lists from large-scale experiments. Nucleic Acids Research, 35 [↩]
- Hawrylycz, M., Martone, M. E., Ascoli, G. A., Bjaalie, J. G., Dong, H.-W., Ghosh, S. S., Gillis, J., Hertzano, R., Haynor, D. R., Hof, P. R., Kim, Y., Lein, E., Liu, Y., Miller, J. A., Mitra, P. P., Mukamel, E., Ng, L., Osumi-Sutherland, D., Peng, H., … Zingg, B. (2023). A guide to the BRAIN Initiative Cell Census Network data ecosystem. PLoS Biology, 21(6), e3002133 [↩]
- Hodge, R. D., Bakken, T. E., Miller, J. A., Smith, K. A., Barkan, E. R., Graybuck, L. T., Close, J. L., Long, B., Johansen, N., Penn, O., Yao, Z., Eggermont, J., Höllt, T., Levi, B. P., Shehata, S. I., Aevermann, B., Beller, A., Bertagnolli, D., Brouner, K., … Lein, E. S. (2019). Conserved cell types with divergent features in human versus mouse cortex. Nature, 573(7772), 61–68 [↩]
- Yamawaki, N., Borges, K., Suter, B. A., Harris, K. D., & Shepherd, G. M. G. (2014). A genuine layer 4 in motor cortex with prototypical synaptic circuit connectivity. eLife, 3, e05422 [↩]
- Bakken, T. E., Jorstad, N. L., Hu, Q., Lake, B. B., Tian, W., Kal-mbach, B. E., Crow, M., Hodge, R. D., Krienen, F. M., Sorensen, S. A., Eggermont, J., Yao, Z., Aevermann, B. D., Aldridge, A. I., Bartlett, A., Bertagnolli, D., Casper, T., Castanon, R. G., Crichton, K., … Lein, E. S. (2021). Comparative cellular analysis of motor cortex in human, marmoset and mouse. Nature, 598(7879) [↩]
- Hodge, R. D., Bakken, T. E., Miller, J. A., Smith, K. A., Barkan, E. R., Gray-buck, L. T., Close, J. L., Long, B., Johansen, N., Penn, O., Yao, Z., Eggermont, J., Höllt, T., Levi, B. P., Shehata, S. I., Aever-mann, B., Beller, A., Bertagnolli, D., Brouner, K., … Lein, E. S. (2019). Conserved cell types with divergent features in human versus mouse cortex. Nature, 573(7772), 61–68 [↩]
- Goralski, T. M., Meyerdirk, L., Breton, L., Brasseur, L., Kurgat, K., DeWeerd, D., Turner, L., Becker, K., Adams, M., Newhouse, D. J., & Henderson, M. X. (2024). Spatial transcriptomics reveals molecular dysfunction associated with cortical Lewy pathology. Nature Communications, 15(1), 2642 [↩]
- Koopmans, F., van Nierop, P., Andres-Alonso, M., Byrnes, A., Cijsouw, T., Coba, M. P., Cornelisse, L. N., Farrell, R. J., Goldschmidt, H. L., Howrigan, D. P., Hussain, N. K., Imig, C., de Jong, A. P. H., Jung, H., Kohansalnodehi, M., Kramarz, B., Lipstein, N., Lovering, R. C., MacGillavry, H., … Verhage, M. (2019). SynGO: An Evi-dence-Based, Expert-Curated Knowledge Base for the Synapse. Neuron, 103(2), 217-234.e4 [↩]
- García-Cabezas, M. Á., & Barbas, H. (2014). Area 4 has layer IV in adult primates. The European Journal of Neuroscience, 39(11), 1824–1834 [↩]
- Jin, S., Plikus, M. V., & Nie, Q. (2023). CellChat for systematic analysis of cell-cell communication from single-cell and spatially resolved transcriptomics. bioRxiv [↩]
- Donovan, A. P. A., & Basson, M. A. (2017). The neuroanatomy of autism—A developmental perspective. Journal of Anatomy, 230(1), 4–15 [↩]
- Franke, B., Faraone, S. V., Asherson, P., Buitelaar, J., Bau, C. H. D., Ramos-Quiroga, J. A., Mick, E., Grevet, E. H., Johansson, S., Haavik, J., Lesch, K.-P., Cormand, B., & Reif, A. (2012). The genetics of at-tention deficit/hyperactivity disorder in adults, a review. Molecu-lar Psychiatry, 17(10), 960–987 [↩]
- Thapar, A., & Stergiakouli, E. (2008). An Overview on the Genetics of ADHD. Xin Li Xue Bao. Acta Psychologica Sinica, 40(10), 1088–1098) [↩]
- Genovese, A., & Butler, M. G. (2023). The Autism Spectrum: Behavioral, Psychiatric and Genetic Associations. Genes, 14(3) [↩]
- Tiira, K., Hakosalo, O., Kareinen, L., Thomas, A., Hielm-Björkman, A., Escriou, C., Arnold, P., & Lohi, H. (2012). Environmental effects on compulsive tail chasing in dogs. PloS One, 7(7), e41684 [↩]
- Vanderhaeghen, P., & Polleux, F. (2023). Developmental mechanisms un-derlying the evolution of human cortical circuits. Nature Reviews Neuroscience, 24(4), 213–232. [↩]
- Pembroke, W. G., Hartl, C. L., & Geschwind, D. H. (2021). Evolutionary conservation and divergence of the human brain transcriptome. Genome Biology, 22(1), 52 [↩]
- Kharchenko, P. V. (2021). Publisher Correction: The triumphs and limitations of computational methods for scRNA-seq. Nature Methods, 18(7), 835–835 [↩]
- Kaikkonen, M. U., Lam, M. T. Y., & Glass, C. K. (2011). Non-coding RNAs as regulators of gene expression and epigenetics. Cardiovascular Research, 90(3), 430–440 [↩]