WO2022221591A1 - Voxelisation de protéine à canaux multiples pour prédire une pathogénicité d'un variant à l'aide de réseaux neuronaux convolutifs profonds - Google Patents

Voxelisation de protéine à canaux multiples pour prédire une pathogénicité d'un variant à l'aide de réseaux neuronaux convolutifs profonds Download PDF

Info

Publication number
WO2022221591A1
WO2022221591A1 PCT/US2022/024916 US2022024916W WO2022221591A1 WO 2022221591 A1 WO2022221591 A1 WO 2022221591A1 US 2022024916 W US2022024916 W US 2022024916W WO 2022221591 A1 WO2022221591 A1 WO 2022221591A1
Authority
WO
WIPO (PCT)
Prior art keywords
amino acid
voxel
channels
atom
voxels
Prior art date
Application number
PCT/US2022/024916
Other languages
English (en)
Inventor
Tobias HAMP
Hong Gao
Kai-How FARH
Original Assignee
Illumina, Inc.
Illumina Cambridge Limited
Priority date (The priority date is an assumption and is not a legal conclusion. Google has not performed a legal analysis and makes no representation as to the accuracy of the date listed.)
Filing date
Publication date
Priority claimed from US17/703,958 external-priority patent/US20220336057A1/en
Application filed by Illumina, Inc., Illumina Cambridge Limited filed Critical Illumina, Inc.
Priority to AU2022258691A priority Critical patent/AU2022258691A1/en
Priority to CN202280027967.1A priority patent/CN117178327A/zh
Priority to KR1020237034825A priority patent/KR20230170680A/ko
Priority to BR112023021266A priority patent/BR112023021266A2/pt
Priority to IL307661A priority patent/IL307661A/en
Priority to JP2023563033A priority patent/JP2024513995A/ja
Priority to EP22726207.8A priority patent/EP4323991A1/fr
Priority to CA3215514A priority patent/CA3215514A1/fr
Publication of WO2022221591A1 publication Critical patent/WO2022221591A1/fr

Links

Classifications

    • GPHYSICS
    • G16INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR SPECIFIC APPLICATION FIELDS
    • G16BBIOINFORMATICS, i.e. INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR GENETIC OR PROTEIN-RELATED DATA PROCESSING IN COMPUTATIONAL MOLECULAR BIOLOGY
    • G16B15/00ICT specially adapted for analysing two-dimensional or three-dimensional molecular structures, e.g. structural or functional relations or structure alignment
    • GPHYSICS
    • G06COMPUTING; CALCULATING OR COUNTING
    • G06NCOMPUTING ARRANGEMENTS BASED ON SPECIFIC COMPUTATIONAL MODELS
    • G06N3/00Computing arrangements based on biological models
    • G06N3/02Neural networks
    • G06N3/04Architecture, e.g. interconnection topology
    • G06N3/045Combinations of networks
    • GPHYSICS
    • G16INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR SPECIFIC APPLICATION FIELDS
    • G16BBIOINFORMATICS, i.e. INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR GENETIC OR PROTEIN-RELATED DATA PROCESSING IN COMPUTATIONAL MOLECULAR BIOLOGY
    • G16B20/00ICT specially adapted for functional genomics or proteomics, e.g. genotype-phenotype associations
    • GPHYSICS
    • G16INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR SPECIFIC APPLICATION FIELDS
    • G16BBIOINFORMATICS, i.e. INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR GENETIC OR PROTEIN-RELATED DATA PROCESSING IN COMPUTATIONAL MOLECULAR BIOLOGY
    • G16B30/00ICT specially adapted for sequence analysis involving nucleotides or amino acids
    • GPHYSICS
    • G16INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR SPECIFIC APPLICATION FIELDS
    • G16BBIOINFORMATICS, i.e. INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR GENETIC OR PROTEIN-RELATED DATA PROCESSING IN COMPUTATIONAL MOLECULAR BIOLOGY
    • G16B40/00ICT specially adapted for biostatistics; ICT specially adapted for bioinformatics-related machine learning or data mining, e.g. knowledge discovery or pattern finding
    • G16B40/20Supervised data analysis
    • GPHYSICS
    • G06COMPUTING; CALCULATING OR COUNTING
    • G06NCOMPUTING ARRANGEMENTS BASED ON SPECIFIC COMPUTATIONAL MODELS
    • G06N3/00Computing arrangements based on biological models
    • G06N3/02Neural networks
    • G06N3/04Architecture, e.g. interconnection topology
    • G06N3/044Recurrent networks, e.g. Hopfield networks
    • GPHYSICS
    • G06COMPUTING; CALCULATING OR COUNTING
    • G06NCOMPUTING ARRANGEMENTS BASED ON SPECIFIC COMPUTATIONAL MODELS
    • G06N3/00Computing arrangements based on biological models
    • G06N3/02Neural networks
    • G06N3/08Learning methods
    • G06N3/084Backpropagation, e.g. using gradient descent

Definitions

  • the technology disclosed relates to artificial intelligence type computers and digital data processing systems and corresponding data processing methods and products for emulation of intelligence (i.e., knowledge based systems, reasoning systems, and knowledge acquisition systems); and including systems for reasoning with uncertainty (e.g ., fuzzy logic systems), adaptive systems, machine learning systems, and artificial neural networks.
  • intelligence i.e., knowledge based systems, reasoning systems, and knowledge acquisition systems
  • systems for reasoning with uncertainty e.g ., fuzzy logic systems
  • adaptive systems e.g ., machine learning systems
  • artificial neural networks e.g., neural networks.
  • Genomics in the broad sense, also referred to as functional genomics, aims to characterize the function of every genomic element of an organism by using genome-scale assays such as genome sequencing, transcriptome profiling and proteomics.
  • Genomics arose as a data-driven science — it operates by discovering novel properties from explorations of genome- scale data rather than by testing preconceived models and hypotheses.
  • Applications of genomics include finding associations between genotype and phenotype, discovering biomarkers for patient stratification, predicting the function of genes, and charting biochemically active genomic regions such as transcriptional enhancers.
  • Genomics data are too large and too complex to be mined solely by visual investigation of pairwise correlations. Instead, analytical tools are required to support the discovery of unanticipated relationships, to derive novel hypotheses and models and to make predictions.
  • machine learning algorithms are designed to automatically detect patterns in data.
  • machine learning algorithms are suited to data-driven sciences and, in particular, to genomics.
  • the performance of machine learning algorithms can strongly depend on how the data are represented, that is, on how each variable (also called a feature) is computed. For instance, to classify a tumor as malign or benign from a fluorescent microscopy image, a preprocessing algorithm could detect cells, identify the cell type, and generate a list of cell counts for each cell type.
  • a machine learning model can take the estimated cell counts, which are examples of handcrafted features, as input features to classify the tumor.
  • a central issue is that classification performance depends heavily on the quality and the relevance of these features. For example, relevant visual features such as cell morphology, distances between cells or localization within an organ are not captured in cell counts, and this incomplete representation of the data may reduce classification accuracy.
  • Deep learning a subdiscipline of machine learning, addresses this issue by embedding the computation of features into the machine learning model itself to yield end-to-end models.
  • This outcome has been realized through the development of deep neural networks, machine learning models that comprise successive elementary operations, which compute increasingly more complex features by taking the results of preceding operations as input.
  • Deep neural networks are able to improve prediction accuracy by discovering relevant features of high complexity, such as the cell morphology and spatial organization of cells in the above example.
  • the construction and training of deep neural networks have been enabled by the explosion of data, algorithmic advances, and substantial increases in computational capacity, particularly through the use of graphical processing units (GPUs).
  • GPUs graphical processing units
  • the goal of supervised learning is to obtain a model that takes features as input and returns a prediction for a so-called target variable.
  • An example of a supervised learning problem is one that predicts whether an intron is spliced out or not (the target) given features on the RNA such as the presence or absence of the canonical splice site sequence, the location of the splicing branchpoint or intron length.
  • Training a machine learning model refers to learning its parameters, which commonly involves minimizing a loss function on training data with the aim of making accurate predictions on unseen data.
  • the input data can be represented as a table with multiple columns, or features, each of which contains numerical or categorical data that are potentially useful for making predictions.
  • Some input data are naturally represented as features in a table (such as temperature or time), whereas other input data need to be first transformed (such as deoxyribonucleic acid (DNA) sequence into Umer counts) using a process called feature extraction to fit a tabular representation.
  • DNA deoxyribonucleic acid
  • the presence or absence of the canonical splice site sequence, the location of the splicing branchpoint and the intron length can be preprocessed features collected in a tabular format.
  • Tabular data are standard for a wide range of supervised machine learning models, ranging from simple linear models, such as logistic regression, to more flexible nonlinear models, such as neural networks and many others.
  • Logistic regression is a binary classifier, that is, a supervised learning model that predicts a binary target variable. Specifically, logistic regression predicts the probability of the positive class by computing a weighted sum of the input features mapped to the [0,1] interval using the sigmoid function, a type of activation function. The parameters of logistic regression, or other linear classifiers that use different activation functions, are the weights in the weighted sum. Linear classifiers fail when the classes, for instance, that of an intron spliced out or not, cannot be well discriminated with a weighted sum of input features. To improve predictive performance, new input features can be manually added by transforming or combining existing features in new ways, for example, by taking powers or pairwise products.
  • Neural networks use hidden layers to learn these nonlinear feature transformations automatically. Each hidden layer can be thought of as multiple linear models with their output transformed by a nonlinear activation function, such as the sigmoid function or the more popular rectified-linear unit (ReLU). Together, these layers compose the input features into relevant complex patterns, which facilitates the task of distinguishing two classes.
  • Deep neural networks use many hidden layers, and a layer is said to be fully- connected when each neuron receives inputs from all neurons of the preceding layer. Neural networks are commonly trained using stochastic gradient descent, an algorithm suited to training models on very large data sets. Implementation of neural networks using modem deep learning frameworks enables rapid prototyping with different architectures and data sets.
  • Fully-connected neural networks can be used for a number of genomics applications, which include predicting the percentage of exons spliced in for a given sequence from sequence features such as the presence of binding motifs of splice factors or sequence conservation; prioritizing potential disease- causing genetic variants; and predicting c/.s-regulatory elements in a given genomic region using features such as chromatin marks, gene expression and evolutionary conservation.
  • a convolutional layer is a special form of fully-connected layer in which the same fully-connected layer is applied locally, for example, in a 6 bp window, to all sequence positions. This approach can also be viewed as scanning the sequence using multiple PWMs, for example, for transcription factors GATA1 and TALI. By using the same model parameters across positions, the total number of parameters is drastically reduced, and the network is able to detect a motif at positions not seen during training.
  • Each convolutional layer scans the sequence with several filters by producing a scalar value at every position, which quantifies the match between the filter and the sequence.
  • a nonlinear activation function commonly ReLU
  • a pooling operation is applied, which aggregates the activations in contiguous bins across the positional axis, commonly taking the maximal or average activation for each channel. Pooling reduces the effective sequence length and coarsens the signal.
  • the subsequent convolutional layer composes the output of the previous layer and is able to detect whether a GATA1 motif and TALI motif were present at some distance range.
  • the output of the convolutional layers can be used as input to a fully- connected neural network to perform the final prediction task.
  • different types of neural network layers e.g ., fully-connected layers and convolutional layers
  • Convolutional neural networks can predict various molecular phenotypes on the basis of DNA sequence alone. Applications include classifying transcription factor binding sites and predicting molecular phenotypes such as chromatin features, DNA contact maps, DNA methylation, gene expression, translation efficiency, RBP binding, and microRNA (miRNA) targets. In addition to predicting molecular phenotypes from the sequence, convolutional neural networks can be applied to more technical tasks traditionally addressed by handcrafted bioinformatics pipelines. For example, convolutional neural networks can predict the specificity of guide RNA, denoise ChIP-seq, enhance Hi-C data resolution, predict the laboratory of origin from DNA sequences and call genetic variants.
  • Convolutional neural networks have also been employed to model long-range dependencies in the genome. Although interacting regulatory elements may be distantly located on the unfolded linear DNA sequence, these elements are often proximal in the actual 3D chromatin conformation. Hence, modelling molecular phenotypes from the linear DNA sequence, albeit a crude approximation of the chromatin, can be improved by allowing for long-range dependencies and allowing the model to implicitly learn aspects of the 3D organization, such as promoter-enhancer looping. This is achieved by using dilated convolutions, which have a receptive field of up to 32 kb.
  • Dilated convolutions also allow splice sites to be predicted from sequence using a receptive field of 10 kb, thereby enabling the integration of genetic sequence across distances as long as typical human introns ( See Jaganathan, K. et al. Predicting splicing from primary sequence with deep learning. Cell 176, 535-548 (2019)).
  • Recurrent neural networks are an alternative to convolutional neural networks for processing sequential data, such as DNA sequences or time series, that implement a different parameter-sharing scheme.
  • Recurrent neural networks apply the same operation to each sequence element. The operation takes as input the memory of the previous sequence element and the new input. It updates the memory and optionally emits an output, which is either passed on to subsequent layers or is directly used as model predictions.
  • recurrent neural networks are invariant to the position index in the processed sequence. For example, a recurrent neural network can detect an open reading frame in a DNA sequence regardless of the position in the sequence. This task requires the recognition of a certain series of inputs, such as the start codon followed by an in-frame stop codon.
  • recurrent neural networks over convolutional neural networks are, in theory, able to carry over information through infinitely long sequences via memory. Furthermore, recurrent neural networks can naturally process sequences of widely varying length, such as mRNA sequences. However, convolutional neural networks combined with various tricks (such as dilated convolutions) can reach comparable or even better performances than recurrent neural networks on sequence-modelling tasks, such as audio synthesis and machine translation. Recurrent neural networks can aggregate the outputs of convolutional neural networks for predicting single-cell DNA methylation states, RBP binding, transcription factor binding, and DNA accessibility. Moreover, because recurrent neural networks apply a sequential operation, they cannot be easily parallelized and are hence much slower to compute than convolutional neural networks.
  • Each human has a unique genetic code, though a large portion of the human genetic code is common for all humans.
  • a human genetic code may include an outlier, called a genetic variant, that may be common among individuals of a relatively small group of the human population.
  • a particular human protein may comprise a specific sequence of amino acids, whereas a variant of that protein may differ by one amino acid in the otherwise same specific sequence.
  • Genetic variants may be pathogenetic, leading to diseases. Though most of such genetic variants have been depleted from genomes by natural selection, an ability to identify which genetic variants are likely to be pathogenic can help researchers focus on these genetic variants to gain an understanding of the corresponding diseases and their diagnostics, treatments, or cures. The clinical interpretation of millions of human genetic variants remains unclear. Some of the most frequent pathogenic variants are single nucleotide missense mutations that change the amino acid of a protein. However, not all missense mutations are pathogenic.
  • Models that can predict molecular phenotypes directly from biological sequences can be used as in silico perturbation tools to probe the associations between genetic variation and phenotypic variation and have emerged as new methods for quantitative trait loci identification and variant prioritization.
  • These approaches are of major importance given that the majority of variants identified by genome-wide association studies of complex phenotypes are non-coding, which makes it challenging to estimate their effects and contribution to phenotypes.
  • linkage disequilibrium results in blocks of variants being co-inherited, which creates difficulties in pinpointing individual causal variants.
  • sequence-based deep learning models that can be used as interrogation tools for assessing the impact of such variants offer a promising approach to find potential drivers of complex phenotypes.
  • One example includes predicting the effect of non-coding single-nucleotide variants and short insertions or deletions (indels) indirectly from the difference between two variants in terms of transcription factor binding, chromatin accessibility or gene expression predictions.
  • Another example includes predicting novel splice site creation from sequence or quantitative effects of genetic variants on splicing.
  • PrimateAI outperforms prior methods when trained directly upon sequence alignments. PrimateAI learns important protein domains, conserved amino acid positions, and sequence dependencies directly from the training data consisting of about 120,000 human samples. PrimateAI substantially exceeds the performance of other variant pathogenicity prediction tools in differentiating benign and pathogenic de-novo mutations in candidate developmental disorder genes, and in reproducing prior knowledge in ClinVar. These results suggest that PrimateAI is an important step forward for variant classification tools that may lessen the reliance of clinical reporting on prior knowledge.
  • Protein sites are microenvironments within a protein structure, distinguished by their structural or functional role. A site can be defined by a three-dimensional (3D) location and a local neighborhood around this location in which the structure or function exists.
  • 3D three-dimensional
  • Central to rational protein engineering is the understanding of how the structural arrangement of amino acids creates functional characteristics within protein sites. Determination of the structural and functional roles of individual amino acids within a protein provides information to help engineer and alter protein functions. Identifying functionally or structurally important amino acids allows focused engineering efforts such as site-directed mutagenesis for altering targeted protein functional properties. Alternatively, this knowledge can help avoid engineering designs that would abolish a desired function.
  • FIG. 1 is a flow diagram that illustrates a process of a system for determining pathogenicity of variants, according to various implementations of the technology disclosed.
  • Figure 2 schematically illustrates an example reference amino acid sequence of a protein and an alternative amino acid sequence of the protein, in accordance with one implementation of the technology disclosed.
  • Figure 3 illustrates amino acid-wise classification of atoms of amino acids in the reference amino acid sequence of Figure 2, in accordance with one implementation of the technology disclosed.
  • Figure 4 illustrates amino acid-wise attribution of 3D atomic coordinates of the alpha- carbon atoms classified in Figure 3 on an amino acid-basis, in accordance with one implementation of the technology disclosed.
  • Figure 5 schematically illustrates a process of determining voxel-wise distance values, in accordance with one implementation of the technology disclosed.
  • Figure 6 shows an example of twenty-one amino acid-wise distance channels, in accordance with one implementation of the technology disclosed.
  • Figure 7 is a schematic diagram of a distance channel tensor, in accordance with one implementation of the technology disclosed.
  • Figure 8 shows one-hot encodings of the reference amino acid and the alternative amino acid from Figure 2, in accordance with one implementation of the technology disclosed.
  • Figure 9 is a schematic diagram of a voxelized one-hot encoded reference amino acid and a voxelized one-hot encoded variant/altemative amino acid, in accordance with one implementation of the technology disclosed.
  • Figure 10 schematically illustrates a concatenation process that voxel -wise concatenates the distance channel tensor of Figure 7 and a reference allele tensor, in accordance with one implementation of the technology disclosed.
  • Figure 11 schematically illustrates a concatenation process that voxel-wise concatenates the distance channel tensor of Figure 7, the reference allele tensor of Figure 10, and an alternative allele tensor, in accordance with one implementation of the technology disclosed.
  • Figure 12 is a flow diagram that illustrates a process of a system for determining and assigning pan-amino acid conservation frequencies of nearest atoms to voxels (voxelizing), in accordance with one implementation of the technology disclosed.
  • Figure 13 illustrates voxel s-to-nearest amino acids, in accordance with one implementation of the technology disclosed.
  • Figure 14 shows an example multi -sequence alignment of the reference amino acid sequence across a ninety-nine species, in accordance with one implementation of the technology disclosed.
  • Figure 15 shows an example of determining a pan-amino acid conservation frequencies sequence for a particular voxel, in accordance with one implementation of the technology disclosed.
  • Figure 16 shows respective pan-amino acid conservation frequencies determined for respective voxels using the position frequency logic described in Figure 15, in accordance with one implementation of the technology disclosed.
  • Figure 17 illustrates voxelized per-voxel evolutionary profiles, in accordance with one implementation of the technology disclosed.
  • Figure 18 depicts example of an evolutionary profiles tensor, in accordance with one implementation of the technology disclosed.
  • Figure 19 is a flow diagram that illustrates a process of a system for determining and assigning per-amino acid conservation frequencies of nearest atoms to voxels (voxelizing), in accordance with one implementation of the technology disclosed.
  • Figure 20 shows various examples of voxelized annotation channels that are concatenated with the distance channel tensor, in accordance with one implementation of the technology disclosed.
  • Figure 21 illustrates different combinations and permutations of input channels that can be provided as inputs to a pathogenicity classifier for pathogenicity determination of a target variant, in accordance with one implementation of the technology disclosed.
  • Figure 22 shows different methods of calculating the disclosed distance channels, in accordance with various implementations of the technology disclosed.
  • Figure 23 shows different examples of the evolutionary channels, in accordance with various implementations of the technology disclosed.
  • Figure 24 shows different examples of the annotations channels, in accordance with various implementations of the technology disclosed.
  • Figure 25 shows different examples of the structure confidence channels, in accordance with various implementations of the technology disclosed.
  • Figure 26 shows an example processing architecture of the pathogenicity classifier, in accordance with one implementation of the technology disclosed.
  • Figure 27 shows an example processing architecture of the pathogenicity classifier, in accordance with one implementation of the technology disclosed.
  • Figures 28, 29, 30, and 31 use PrimateAI as a benchmark model to demonstrate the disclosed PrimateAI 3D’s classification superiority over PrimateAI.
  • Figures 32A and 32B show the disclosed efficient voxelization process, in accordance with various implementations of the technology disclosed.
  • Figure 33 depicts how atoms are associated with voxels that contain the atoms, in accordance with one implementation of the technology disclosed.
  • Figure 34 shows generating voxel-to-atoms mapping from atom-to-voxels mapping to identify nearest atoms on a voxel-by-voxel basis, in accordance with one implementation of the technology disclosed.
  • Figures 35 A and 35B illustrate how the disclosed efficient voxelization has a runtime complexity of 0(#atoms) versus the runtime complexity of 0(#atoms * #voxels) without the use of disclosed efficient voxelization.
  • Figure 36 shows an example computer system that can be used to implement the technology disclosed.
  • the functional blocks are not necessarily indicative of the division between hardware circuitry.
  • one or more of the functional blocks e.g ., modules, processors, or memories
  • the programs may be stand-alone programs, may be incorporated as subroutines in an operating system, may be functions in an installed software package, and the like.
  • modules can be implemented in hardware or software, and need not be divided up in precisely the same blocks as shown in the figures. Some of the modules can also be implemented on different processors, computers, or servers, or spread among a number of different processors, computers, or servers. In addition, it will be appreciated that some of the modules can be combined, operated in parallel or in a different sequence than that shown in the figures without affecting the functions achieved.
  • the modules in the figures can also be thought of as flowchart steps in a method.
  • a module also need not necessarily have all its code disposed contiguously in memory; some parts of the code can be separated from other parts of the code with code from other modules or other functions disposed in between.
  • FIG. 1 is a flow diagram that illustrates a process 100 of a system for determining pathogenicity of variants.
  • a sequence accessor 104 of the system accesses reference and alternative amino acid sequences.
  • a 3D structure generator 114 of the system generates 3D protein structures for a reference amino acid sequence.
  • the 3D protein structures are homology models of human proteins.
  • a so-called SwissModel homology modelling pipeline provides a public repository of predicted human protein structures.
  • a so-called HHpred homology modelling uses a tool called Modeller to predict the structure of a target protein from template structures.
  • Proteins are represented by a collection of atoms and their coordinates in 3D space.
  • An amino acid can have a variety of atoms, such as carbon atoms, oxygen (O) atoms, nitrogen (N) atoms, and hydrogen (H) atoms.
  • the atoms can be further classified as side chain atoms and backbone atoms.
  • the backbone carbon atoms can include alpha-carbon (C a ) atoms and beta- carbon (C (t ) atoms.
  • a coordinate classifier 124 of the system classifies 3D atomic coordinates of the 3D protein structures on an amino acid-basis.
  • the amino acid-wise classification involves attributing the 3D atomic coordinates to the twenty-one amino acid categories (including stop or gap amino acid category).
  • an amino acid-wise classification of alpha-carbon atoms can respectively list alpha-carbon atoms under each of the twenty-one amino acid categories.
  • an amino acid-wise classification of beta- carbon atoms can respectively list beta-carbon atoms under each of the twenty-one amino acid categories.
  • an amino acid-wise classification of oxygen atoms can respectively list oxygen atoms under each of the twenty-one amino acid categories.
  • an amino acid-wise classification of nitrogen atoms can respectively list nitrogen atoms under each of the twenty-one amino acid categories.
  • an amino acid-wise classification of hydrogen atoms can respectively list hydrogen atoms under each of the twenty-one amino acid categories.
  • the amino acid-wise classification can include a subset of the twenty-one amino acid categories and a subset of the different atomic elements.
  • a voxel grid generator 134 of the system instantiates a voxel grid.
  • the voxel grid can have any resolution, for example, 3x3x3, 5x5x5, 7x7x7, and so on.
  • Voxels in the voxel grid can be of any size, for example, one angstrom (A) on each side, two A on each side, three A on each side, and so on.
  • A angstrom
  • these example dimensions refer to cubic dimensions because voxels are cubes.
  • these example dimensions are non-limiting, and the voxels can have any cubic dimensions.
  • a voxel grid centerer 144 of the system centers the voxel grid at the reference amino acid experiencing a target variant at the amino acid level.
  • the voxel grid is centered at an atomic coordinate of a particular atom of the reference amino acid experiencing the target variant, for example, the 3D atomic coordinate of the alpha-carbon atom of the reference amino acid experiencing the target variant.
  • the voxels in the voxel grid can have a plurality of channels (or features).
  • the voxels in the voxel grid have a plurality of distance channels (e.g ., twenty- one distance channels for the twenty-one amino acid categories, respectively (including stop or gap amino acid category)).
  • a distance channel generator 154 of the system generates amino acid-wise distance channels for the voxels in the voxel grid. The distance channels are independently generated for each of the twenty-one amino acid categories.
  • an Alanine distance channel includes twenty-seven distance values for the twenty-seven voxels in the voxel grid, respectively.
  • the twenty-seven distance values in the Alanine distance channel are measured from respective centers of the twenty-seven voxels in the voxel grid to respective nearest atoms in the Alanine amino acid category.
  • the Alanine amino acid category includes only alpha-carbon atoms and therefore the nearest atoms are those Alanine alpha-carbon atoms that are most proximate to the twenty-seven voxels in the voxel grid, respectively.
  • the Alanine amino acid category includes only beta-carbon atoms and therefore the nearest atoms are those Alanine beta-carbon atoms that are most proximate to the twenty-seven voxels in the voxel grid, respectively.
  • the Alanine amino acid category includes only oxygen atoms and therefore the nearest atoms are those Alanine oxygen atoms that are most proximate to the twenty-seven voxels in the voxel grid, respectively.
  • the Alanine amino acid category includes only nitrogen atoms and therefore the nearest atoms are those Alanine nitrogen atoms that are most proximate to the twenty-seven voxels in the voxel grid, respectively.
  • the Alanine amino acid category includes only hydrogen atoms and therefore the nearest atoms are those Alanine hydrogen atoms that are most proximate to the twenty-seven voxels in the voxel grid, respectively.
  • the distance channel generator 154 Like the Alanine distance channel, the distance channel generator 154 generates a distance channel (i.e., a set of voxel -wise distance values) for each of the remaining amino acid categories. In other implementations, the distance channel generator 154 generates distance channels only for a subset of the twenty-one amino acid categories.
  • the selection of the nearest atoms is not confined to a particular atom type. That is, within a subject amino acid category, the nearest atom to a particular voxel is selected, irrespective of the atomic element of the nearest atom, and the distance value for the particular voxel calculated for inclusion in the distance channel for the subject amino acid category.
  • the distance channels are generated on an atomic element-basis.
  • distance values can be generated for atom element categories, irrespective of the amino acids to which the atoms belong.
  • the atoms of amino acids in the reference amino acid sequence span seven atomic elements: carbon, oxygen, nitrogen, hydrogen, calcium, iodine, and sulfur.
  • the voxels in the voxel grid are configured to have seven distance channels, such that each of the seven distance channels have twenty-seven voxel wise distance values that specify distances to nearest atoms only within a corresponding atomic element category.
  • distance channels for only a subset of the seven atomic elements can be generated.
  • the atomic element categories and the distance channel generation can be further stratified into variations of a same atomic element, for example, alpha-carbon (C a ) atoms and beta-carbon (Cp) atoms.
  • the distance channels can be generated on an atom type- basis, for example, distance channels only for side chain atoms and distance channels only for backbone atoms.
  • the nearest atoms can be searched within a predefined maximum scan radius from the voxel centers (e.g ., six angstrom (A)). Also, multiple atoms can be nearest to a same voxel in the voxel grid.
  • the distances are calculated between 3D coordinates of the voxel centers and 3D atomic coordinates of the atoms. Also, the distance channels are generated with the voxel grid centered at a same location (e.g., centered at the 3D atomic coordinate of the alpha-carbon atom of the reference amino acid experiencing the target variant).
  • the distances can be Euclidean distances. Also, the distances can be parameterized by atom size (or atom influence) (e.g, by using Lennard-Jones potential and/or Van der Waals atom radius of the atom in question). Also, the distance values can be normalized by the maximum scan radius, or by a maximum observed distance value of the furthest nearest atom within a subject amino acid category or a subject atomic element category or a subject atom type category. In some implementations, the distances between the voxels and the atoms are calculated based on polar coordinates of the voxels and the atoms. The polar coordinates are parameterized by angles between the voxels and the atoms.
  • this angel information is used to generate an angle channel for the voxels (i.e., independent of the distance channels).
  • angles between a nearest atom and neighboring atoms e.g, backbone atoms
  • the voxels in the voxel grid can also have reference allele and alternative allele channels.
  • a one-hot encoder 164 of the system generates a reference one-hot encoding of a reference amino acid in the reference amino acid sequence and an alternative one- hot encoding of an alternative amino acid in an alternative amino acid sequence.
  • the reference amino acid experiences the target variant.
  • the alternative amino acid is the target variant.
  • the reference amino acid and the alternative amino acid are located at a same position respectively in the reference amino acid sequence and the alternative amino acid sequence.
  • the reference amino acid sequence and the alternative amino acid sequence have the same position-wise amino acid composition with one exception. The exception is the position that has the reference amino acid in the reference amino acid sequence and the alternative amino acid in the alternative amino acid sequence.
  • a concatenator 174 of the system concatenates the amino acid-wise distance channels and the reference and alternative one-hot encodings.
  • the concatenator 174 concatenates the atomic element-wise distance channels and the reference and alternative one-hot encodings.
  • the concatenator 174 concatenates the atomic type-wise distance channels and the reference and alternative one-hot encodings.
  • runtime logic 184 of the system processes the concatenated amino acid- wise/atomic element-wise/atomic type-wise distance channels and the reference and alternative one-hot encodings through a pathogenicity classifier (pathogenicity determination engine) to determine a pathogenicity of the target variant, which is in turn inferred as a pathogenicity determination of the underlying nucleotide variant that creates the target variant at the amino acid level.
  • the pathogenicity classifier is trained using labelled datasets of benign and pathogenic variants, for example, using the backpropagation algorithm. Additional details about the labelled datasets of benign and pathogenic variants and example architectures and training of the pathogenicity classifier can be found in commonly owned US Patent Application Nos. 16/160,903; 16/160,986; 16/160,968; and 16/407,149.
  • FIG. 2 schematically illustrates a reference amino acid sequence 202 of a protein 200 and an alternative amino acid sequence 212 of the protein 200.
  • the protein 200 comprises N amino acids. Positions of the amino acids in the protein 200 are labelled 1, 2, 3...N.
  • position 16 is the location that experiences an amino acid variant 214 (mutation) caused by an underlying nucleotide variant.
  • position 1 has reference amino acid Phenylalanine (F)
  • position 16 has reference amino acid Glycine (G) 204
  • position N e.g ., the last amino acid of the sequence 202
  • L Leucine
  • the alternative amino acid sequence 212 is the same as the reference amino acid sequence 202 except for the variant 214 at position 16, which contains the alternative amino acid Alanine (A) 214 instead of the reference amino acid Glycine (G) 204.
  • Figure 3 illustrates amino acid-wise classification of atoms of amino acids in the reference amino acid sequence 202, also referred to herein as “atom classification 300.”
  • Specific types of amino acids among the twenty natural amino acids listed in column 302, may repeat in a protein. That is, a particular type of amino acid may occur more than once in a protein. Proteins may also have some undetermined amino acids that are categorized by a twenty-first stop or gap amino acid category.
  • the right column in Figure 3 contains counts of alpha-carbon (C a ) atoms from different amino acids.
  • Figure 3 shows amino acid-wise classification of alpha-carbon (C a ) atoms of the amino acids in the reference amino acid sequence 202.
  • Column 308 of Figure 3 lists the total number of alpha-carbon atoms observed for the reference amino acid sequence 202 in each of the twenty-one amino acid categories. For example, column 308 lists eleven alpha- carbon atoms observed for the Alanine (A) amino acid category. Since each amino acid has only one alpha-carbon atom, this means that Alanine occurs 11 times in the reference amino acid sequence 202. In another example, Arginine (R) occurs thirty-five times in the reference amino acid sequence 202. The total number of alpha-carbon atoms across the twenty-one amino acid categories is eight hundred and twenty-eight.
  • Figure 4 illustrates amino acid-wise attribution of 3D atomic coordinates of the alpha- carbon atoms of the reference amino acid sequence 202 based on the atom classification 300 in Figure 3. This is referred to herein as “atomic coordinates bucketing 400.”
  • lists 404- 440 tabulate the 3D atomic coordinates of the alpha-carbon atoms bucketed to each of the twenty-one amino acid categories.
  • the bucketing 400 in Figure 4 follows the classification 300 of Figure 3.
  • the Alanine amino acid category has eleven alpha-carbon atoms, and therefore, in Figure 4, the Alanine amino acid category has eleven 3D atomic coordinates of the corresponding eleven alpha-carbon atoms from Figure 3.
  • This classification-to-bucketing logic flows from Figure 3 to Figure 4 for other amino acid categories too.
  • this classification-to-bucketing logic is only for representational purposes, and, in other implementations, the technology disclosed need not perform the classification 300 and the bucketing 400 to locate the voxel-wise nearest atoms, and may perform fewer, additional, or different steps.
  • the technology disclosed can locate the voxel-wise nearest atoms by using a sort and search algorithm that returns the voxel-wise nearest atoms from one or more databases in response to a search query configured to accept query parameters like sort criteria (e.g ., amino acid-wise, atomic element-wise, atom type-wise), the predefined maximum scan radius, and the type of distances (e.g., Euclidean, Mahalanobis, normalized, unnormalized).
  • sort criteria e.g ., amino acid-wise, atomic element-wise, atom type-wise
  • the predefined maximum scan radius e.g., Euclidean, Mahalanobis, normalized, unnormalized.
  • type of distances e.g., Euclidean, Mahalanobis, normalized, unnormalized.
  • a plurality of sort and search algorithms from the current or future technical field can be analogous used by a person skilled in the art to locate the voxel-wise nearest atoms.
  • one or more databases may include information regarding the 3D atomic coordinates of the alpha-carbon atoms and other atoms of amino acids in proteins. Such databases may be searchable by specific proteins.
  • the voxels and the voxel grid are 3D entities.
  • the drawings depict, and the description discusses the voxels and the voxel grid in a two-dimensional (2D) format.
  • 2D two-dimensional
  • a 3x3x3 voxel grid of twenty-seven voxels is depicted and described herein as a 3x3 2D pixel grid with nine 2D pixels.
  • the 2D format is used only for representational purposes and is intended to cover the 3D counterparts (i.e., 2D pixels represent 3D voxels and 2D pixel grid represents 3D voxel grid).
  • the drawings are also not scale. For example, voxels of size two angstrom (A) are depicted using a single pixel.
  • FIG. 5 schematically illustrates a process of determining voxel-wise distance values, also referred to herein as “voxel-wise distance calculation 500.”
  • the voxel-wise distance values are calculated only for the Alanine (A) distance channel.
  • the same distance calculation logic is executed for each of the twenty-one amino acid categories to generate twenty-one amino acid-wise distance channels and can be further expanded to other atom types like beta-carbon atoms and other atomic elements like oxygen, nitrogen, and hydrogen, as discussed above with respect to Figure 1.
  • the atoms are randomly rotated prior to the distance calculation to make the training of the pathogenicity classifier invariant to atom orientation.
  • a voxel grid 522 has nine voxels 514 identified with indices (1, 1), (1, 2), (1, 3), (2, 1), (2, 2), (2, 3), (3, 1), (3, 2), and (3, 3).
  • the voxel grid 522 is centered, for example, at the 3D atomic coordinate 532 of the alpha-carbon atom of the Glycine (G) amino acid at position 16 in the reference amino acid sequence 202 because, in the alternative amino acid sequence 212, the position 16 experiences the variant that mutates the Glycine (G) amino acid to the Alanine (A) amino acid, as discussed above with respect to Figure 2.
  • the center of the voxel grid 522 coincides with the center of voxel (2, 2).
  • the centered voxel grid 522 is used for the voxel-wise distance calculation for each of the twenty-one amino acid-wise distance channels.
  • Alanine (A) distance channel distances between the 3D coordinates of respective centers of the nine voxels 514 and the 3D atomic coordinates 402 of the eleven Alanine alpha-carbon atoms are measured to locate a nearest Alanine alpha-carbon atom for each of the nine voxels 514.
  • nine distance values for nine distances between the nine voxels 514 and the respective nearest Alanine alpha-carbon atoms are used to construct the Alanine distance channel.
  • the resulting Alanine distance channel arranges the nine Alanine distance values in the same order as the nine voxels 514 in the voxel grid 522.
  • the above process is executed for each of the twenty-one amino acid categories.
  • the centered voxel grid 522 is similarly used to calculate the Arginine (R) distance channel, such that distances between the 3D coordinates of respective centers of the nine voxels 514 and the 3D atomic coordinates 404 of the thirty-five Arginine alpha-carbon atoms are measured to locate a nearest Arginine alpha-carbon atom for each of the nine voxels 514.
  • nine distance values for nine distances between the nine voxels 514 and the respective nearest Arginine alpha-carbon atoms are used to construct the Arginine distance channel.
  • the resulting Arginine distance channel arranges the nine Arginine distance values in the same order as the nine voxels 514 in the voxel grid 522.
  • the twenty-one amino acid-wise distance channels are voxel-wise encoded to form a distance channel tensor.
  • a distance 512 is between the center of voxel (1, 1) of voxel grid 522 and the nearest alpha-carbon (C a ) atom, which is the Ca A5 atom in list 402. Accordingly, the value assigned to voxel (1, 1) is the distance 512.
  • the Ca A4 atom is the nearest C a atom to the center of voxel (1, 2). Accordingly, the value assigned to voxel (1, 2) is the distance between the center of voxel (1, 2) and the Ca A4 atom.
  • the Ca A6 atom is the nearest C a atom to the center of voxel (2, 1).
  • the value assigned to voxel (2, 1) is the distance between the center of voxel (2, 1) and the Ca A6 atom.
  • the Ca A6 atom is also the nearest C a atom to the center of voxels (3, 2) and (3, 3).
  • the value assigned to voxel (3, 2) is the distance between the center of voxel (3, 2) and the Ca A6 atom and the value assigned to voxel (3, 3) is the distance between the center of voxel (3, 3) and the Ca A6 atom.
  • the distance values assigned to the voxels 514 may be normalized distances.
  • the distance value assigned to voxel (1, 1) may be the distance 512 divided by a maximum distance 502 (predefined maximum scan radius).
  • the nearest-atom distances may be Euclidean distances and the nearest-atom distances may be normalized by dividing the Euclidean distances with a maximum nearest-atom distance (e.g ., such as the maximum distance 502).
  • the distances may be nearest-alpha-carbon atom distances from corresponding voxel centers to nearest alpha-carbon atoms of the corresponding amino acids.
  • the distances may be nearest-beta-carbon atom distances from corresponding voxel centers to nearest beta-carbon atoms of the corresponding amino acids.
  • the distances may be nearest-backbone atom distances from corresponding voxel centers to nearest backbone atoms of the corresponding amino acids.
  • the distances may be nearest-sidechain atom distances from corresponding voxel centers to nearest sidechain atoms of the corresponding amino acids.
  • the distances additionally/altematively can include distances to second, third, fourth nearest atoms, and so on.
  • Figure 6 shows an example of twenty-one amino acid-wise distance channels 600. Each column in Figure 6 corresponds to a respective one of the twenty-one amino acid-wise distance channels 602-642.
  • Each amino acid-wise distance channel comprises a distance value for each of the voxels 514 of the voxel grid 522.
  • the amino acid-wise distance channel 602 for Alanine (A) comprises distance values for respective ones of the voxels 514 of the voxel grid 522.
  • the voxel grid 522 is 3D grid of volume 3x3x3 and comprises twenty-seven voxels.
  • each amino acid-wise distance channel may comprise twenty-seven voxel-wise distance values for the 3x3x3 voxel grid.
  • the technology disclosed uses a directionality parameter to specify the directionality of the reference amino acids in the reference amino acid sequence 202. In some implementations, the technology disclosed uses the directionality parameter to specify the directionality of the alternative amino acids in the alternative amino acid sequence 212. In some implementations, the technology disclosed uses the directionality parameter to specify the position in the protein 200 that experiences the target variant at the amino acid level.
  • all the distance values in the twenty-one amino acid-wise distance channels 602-642 are measured from respective nearest atoms to the voxels 514 in the voxel grid 522.
  • These nearest atoms originate from one of the reference amino acids in the reference amino acid sequence 202.
  • These originating reference amino acids which contain the nearest atoms, can be classified into two categories: (1) those originating reference amino acids that precede the variant-experiencing reference amino acid 204 in the reference amino acid sequence 202 and (2) those originating reference amino acids that succeed the variant- experiencing reference amino acid 204 in the reference amino acid sequence 202.
  • the originating reference amino acids in the first category can be called preceding reference amino acids.
  • the originating reference amino acids in the second category can be called succeeding reference amino acids.
  • the directionality parameter is applied to those distance values in the twenty-one amino acid-wise distance channels 602-642 that are measured from those nearest atoms that originate from the preceding reference amino acids. In one implementation, the directionality parameter is multiplied with such distance values.
  • the directionality parameter can be any number, such as -1.
  • the twenty-one amino acid-wise distance channels 600 include some distance values that indicate to the pathogenicity classifier which end of the protein 200 is the start terminal and which end is the end terminal. This also allows the pathogenicity classifier to reconstruct a protein sequence from the 3D protein structure information supplied by the distance channels and the reference and allele channels.
  • FIG. 7 is a schematic diagram of a distance channel tensor 700.
  • Distance channel tensor 700 is a voxelized representation of the amino acid-wise distance channels 600 from Figure 6.
  • the twenty-one amino acid-wise distance channels 602-642 are concatenated voxel-wise, like RGB channels of a color image.
  • the voxelized dimensionality of the distance channel tensor 700 is 21x3x3x3 (where 21 denotes the twenty-one amino acid categories and 3x3x3 denotes the 3D voxel grid with twenty-seven voxels); although Figure 7 is a 2D depiction of dimensionality 21x3x3.
  • Figure 8 shows one-hot encodings 800 of the reference amino acid 204 and the alternative amino acid 214.
  • left column is a one-hot encoding 802 of the reference amino acid Glycine (G) 204, with one for the Glycine amino acid category and zeros for all other amino acid categories.
  • right column is a one-hot encoding 804 of the variant/altemative amino acid Alanine (A) 214, with one for the Alanine amino acid category and zeros for all other amino acid categories.
  • Figure 9 is a schematic diagram of a voxelized one-hot encoded reference amino acid 902 and a voxelized one-hot encoded variant/alternative amino acid 912.
  • the voxelized one-hot encoded reference amino acid 902 is a voxelized representation of the one-hot encoding 802 of the reference amino acid Glycine (G) 204 from Figure 8.
  • the voxelized one-hot encoded alternative amino acid 912 is a voxelized representation of the one-hot encoding 804 of the variant/altemative amino acid Alanine (A) 214 from Figure 8.
  • the voxelized dimensionality of the voxelized one-hot encoded reference amino acid 902 is 21x1x1x1 (where 21 denotes the twenty-one amino acid categories); although Figure 9 is a 2D depiction of dimensionality 21x1x1.
  • the voxelized dimensionality of the voxelized one-hot encoded alternative amino acid 912 is 21x1x1x1 (where 21 denotes the twenty-one amino acid categories); although Figure 9 is a 2D depiction of dimensionality 21x1x1.
  • Figure 10 schematically illustrates a concatenation process 1000 that voxel-wise concatenates the distance channel tensor 700 of Figure 7 and a reference allele tensor 1004.
  • the reference allele tensor 1004 is a voxel -wise aggregation (repetition/cloning/replication) of the voxelized one-hot encoded reference amino acid 902 from Figure 9.
  • multiple copies of the voxelized one-hot encoded reference amino acid 902 are voxel-wise concatenated according with each other to the spatial arrangement of the voxels 514 in the voxel grid 522, such that the reference allele tensor 1004 has a corresponding copy of the voxelized one-hot encoded reference amino acid 910 for each of the voxels 514 in the voxel grid 522.
  • the concatenation process 1000 produces a concatenated tensor 1010.
  • the voxelized dimensionality of the reference allele tensor 1004 is 21x3x3x3 (where 21 denotes the twenty-one amino acid categories and 3x3x3 denotes the 3D voxel grid with twenty-seven voxels); although Figure 10 is a 2D depiction of the reference allele tensor 1004 having dimensionality 21x3x3.
  • the voxelized dimensionality of the concatenated tensor 1010 is 42x3x3x3; although Figure 10 is a 2D depiction of the concatenated tensor 1010 having dimensionality 42x3x3.
  • Figure 11 schematically illustrates a concatenation process 1100 that voxel-wise concatenates the distance channel tensor 700 of Figure 7, the reference allele tensor 1004 of Figure 10, and an alternative allele tensor 1104.
  • the alternative allele tensor 1104 is a voxel -wise aggregation (repetition/cloning/replication) of the voxelized one-hot encoded alternative amino acid 912 from Figure 9.
  • multiple copies of the voxelized one-hot encoded alternative amino acid 912 are voxel-wise concatenated with each other according to the spatial arrangement of the voxels 514 in the voxel grid 522, such that the alternative allele tensor 1104 has a corresponding copy of the voxelized one-hot encoded alternative amino acid 910 for each of the voxels 514 in the voxel grid 522.
  • the concatenation process 1100 produces a concatenated tensor 1110.
  • the voxelized dimensionality of the alternative allele tensor 1104 is 21x3x3x3 (where 21 denotes the twenty- one amino acid categories and 3x3x3 denotes the 3D voxel grid with twenty-seven voxels); although Figure 11 is a 2D depiction of the alternative allele tensor 1104 having dimensionality 21x3x3.
  • the voxelized dimensionality of the concatenated tensor 1110 is 63x3x3x3; although Figure 11 is a 2D depiction of the concatenated tensor 1110 having dimensionality 63x3x3.
  • the runtime logic 184 processes the concatenated tensor 1110 through the pathogenicity classifier to determine a pathogenicity of the variant/alternative amino acid Alanine (A) 214, which is in turn inferred as a pathogenicity determination of the underlying nucleotide variant that creates the variant/alternative amino acid Alanine (A) 214.
  • the technology disclosed concatenates the distance channel tensor 700, the reference allele tensor 1004, and the alternative allele tensor 1104 with evolutionary channels.
  • One example of the evolutionary channels is pan-amino acid conservation frequencies.
  • Another example of the evolutionary channels is per-amino acid conservation frequencies.
  • the evolutionary channels are constructed using position weight matrices (PWMs). In other implementations, the evolutionary channels are constructed using position specific frequency matrices (PSFMs). In yet other implementations, the evolutionary channels are constructed using computational tools like SIFT, PolyPhen, and PANTHER-PSEC. In yet other implementations, the evolutionary channels are preservation channels based on evolutionary preservation. Preservation is related to conservation, as it also reflects the effect of negative selection that has acted to prevent evolutionary change at a given site in a protein.
  • Figure 12 is a flow diagram that illustrates a process 1200 of a system for determining and assigning pan-amino acid conservation frequencies of nearest atoms to voxels (voxelizing), in accordance with one implementation of the technology disclosed.
  • Figures 12, 13, 14, 15, 16, 17, and 18 are discussed in tandem.
  • a similar sequence finder 1204 of the system retrieves amino acid sequences that are similar (homologous) to the reference amino acid sequence 202.
  • the similar amino acid sequences can be selected from multiple species like primates, mammals, and vertebrates.
  • an aligner 1214 of the system position-wise aligns the reference amino acid sequence 202 with the similar amino acid sequences, i.e., the aligner 1214 performs a multi sequence alignment.
  • Figure 14 shows an example multi-sequence alignment 1400 of the reference amino acid sequence 202 across a ninety-nine species.
  • the multi -sequence alignment 1400 can be partitioned, for example, to generate a first position frequency matrix 1402 for primates, a second position frequency matrix 1412 for mammals, and a third position frequency matrix 1422 for primates.
  • a single position frequency matrix is generated across the ninety-nine species.
  • a pan-amino acid conservation frequency calculator 1224 of the system uses the multi-sequence alignment to determine pan-amino acid conservation frequencies of the reference amino acids in the reference amino acid sequence 202.
  • a nearest atom finder 1234 of the system finds nearest atoms to the voxels 514 in the voxel grid 522.
  • the search for the voxel-wise nearest atoms may not be confined to any particular amino acid category or atom type. That is, the voxel-wise nearest atoms can be selected across the amino acid categories and the amino acid types, as long as they are the most proximate atoms to the respective voxel centers.
  • the search for the voxel-wise nearest atoms may be confined to only a particular atom category, such as only to a particular atomic element like oxygen, nitrogen, and hydrogen, or only to alpha-carbon atoms, or only to beta-carbon atoms, or only to sidechain atoms, or only to backbone atoms.
  • an amino acid selector 1244 of the system selects those reference amino acids in the reference amino acid sequence 202 that contain the nearest atoms identified at the step 1232.
  • Such reference amino acids can be called nearest reference amino acids.
  • Figure 13 shows an example of locating nearest atoms 1302 to the voxels 514 in the voxel grid 522 and respectively mapping nearest reference amino acids 1312 that contain the nearest atoms 1302 to the voxels 514 in the voxel grid 522. This is identified in Figure 13 as “voxel s-to-nearest amino acids mapping 1300.”
  • a voxelizer 1254 of the system voxelizes pan-amino acid conservation frequencies of the nearest reference amino acids.
  • Figure 15 shows an example of determining a pan-amino acid conservation frequencies sequence for the first voxel (1, 1) in the voxel grid 522, also referred to herein as “per-voxel evolutionary profile determination 1500.”
  • the nearest reference amino acid that was mapped to the first voxel (1, 1) is Aspartic acid (D) amino acid at position 15 in the reference amino acid sequence 202.
  • D Aspartic acid
  • the multi -sequence alignment of the reference amino acid sequence 202 with, for example, ninety-nine homologous amino acid sequences of the ninety-nine species is analyzed at position 15.
  • Such a position-specific and cross-species analysis reveals how many instances of amino acids from each of the twenty-one amino acid categories are found at position 15 across the hundred aligned amino acid sequences (i.e., the reference amino acid sequence 202 plus the ninety-nine homologous amino acid sequences).
  • the Aspartic acid (D) amino acid is found at position 15 in ninety-six out of the hundred aligned amino acid sequences. So, the Aspartic acid amino acid category 1504 is assigned a pan-amino acid conservation frequency of 0.96.
  • the Valine (V) acid amino acid is found at position 15 in four out of the hundred aligned amino acid sequences. So, the Valine acid amino acid category 1514 is assigned a pan-amino acid conservation frequency of 0.04. Since no instances of amino acids from other amino acid categories are detected at position 15, the remaining amino acid categories are assigned a pan-amino acid conservation frequency of zero. This way, each of the twenty-one amino acid categories is assigned a respective pan-amino acid conservation frequency, which can be encoded in the pan-amino acid conservation frequencies sequence 1502 for the first voxel (1, 1).
  • Figure 16 shows respective pan-amino acid conservation frequencies 1612-1692 determined for respective ones of the voxels 514 in the voxel grid 522 using the position frequency logic described in Figure 15, also referred to herein as “voxels-to- evolutionary profiles mapping 1600.”
  • Per-voxel evolutionary profiles 1602 are then used by the voxelizer 1254 to generate voxelized per-voxel evolutionary profiles 1700, illustrated in Figure 17.
  • each of the voxels 514 in the voxel grid 522 has a different pan-amino acid conservation frequencies sequence and therefore a different voxelized per-voxel evolutionary profile because the voxels are regularly mapped to different nearest atoms and therefore to different nearest reference amino acids.
  • FIG. 18 depicts example of an evolutionary profiles tensor 1800 in which the voxelized per-voxel evolutionary profiles 1700 are voxel -wise concatenated with each other according to the spatial arrangement of the voxels 514 in the voxel grid 522.
  • the voxelized dimensionality of the evolutionary profiles tensor 1800 is 21x3x3x3 (where 21 denotes the twenty-one amino acid categories and 3x3x3 denotes the 3D voxel grid with twenty-seven voxels); although Figure 18 is a 2D depiction of the evolutionary profiles tensor 1800 having dimensionality 21x3x3.
  • the concatenator 174 voxel-wise concatenates the evolutionary profiles tensor 1800 with the distance channel tensor 700.
  • the evolutionary profiles tensor 1800 is voxel -wise concatenated with the concatenator tensor 1110 to generate a further concatenated tensor of dimensionality 84x3x3x3 (not shown).
  • the runtime logic 184 processes the further concatenated tensor of dimensionality 84x3x3x3 through the pathogenicity classifier to determine the pathogenicity of the target variant, which is in turn inferred as a pathogenicity determination of the underlying nucleotide variant that creates the target variant at the amino acid level.
  • Figure 19 is a flow diagram that illustrates a process 1900 of a system for determining and assigning per-amino acid conservation frequencies of nearest atoms to voxels (voxelizing).
  • a per-amino acid conservation frequency calculator 1924 of the system uses the multi-sequence alignment to determine per-amino acid conservation frequencies of the reference amino acids in the reference amino acid sequence 202.
  • a nearest atom finder 1934 of the system finds, for each of the voxels 514 in the voxel grid 522, twenty-one nearest atoms across each of the twenty-one amino acid categories. Each of the twenty-one nearest atoms is different from each other because they are selected from different amino acid categories. This leads to the selection of twenty-one unique nearest reference amino acids for a particular voxel, which in turn leads to generation of twenty- one unique position frequency matrices for the particular voxel, and which in turn leads to determination of twenty-one unique per-amino acid conservation frequencies for the particular voxel.
  • an amino acid selector 1944 of the system selects, for each of the voxels 514 in the voxel grid 522, twenty-one reference amino acids in the reference amino acid sequence 202 that contain the twenty-one nearest atoms identified at the step 1932.
  • Such reference amino acids can be called nearest reference amino acids.
  • a voxelizer 1954 of the system voxelizes pen-amino acid conservation frequencies of the twenty-one nearest reference amino acids identified for the particular voxel at the step 1942.
  • the twenty-one nearest reference amino acids are necessarily located at twenty- one different positions in the reference amino acid sequence 202 because they correspond to different underlying nearest atoms. Accordingly, for the particular voxel, twenty-one position frequency matrices can be generated for the twenty-one nearest reference amino acids.
  • the twenty-one position frequency matrices can be generated across multiple species whose homologous amino acid sequences are position-wise aligned with the reference amino acid sequence 202, as discussed above with respect to Figures 12 to 15.
  • Figure 20 shows various examples of voxelized annotation channels 2000 that are concatenated with the distance channel tensor 700.
  • the voxelized annotation channels are one-hot indicators for different protein annotations, for example whether an amino acid (residue) is part of a transmembrane region, a signal peptide, an active site, or any other binding site, or whether the residue is subject to posttranslational modifications, PathRatio (See Pei P, Zhang A: A Topological Measurement for Weighted Protein Interaction Network. CSB 2005, 268-278.), etc. Additional examples of the annotation channels can be found below in the Particular Implementations section and in the Claims.
  • the voxelized annotation channels are arranged voxel-wise such that the voxels can have a same annotation sequence like the voxelized reference allele and alternative allele sequences ( e.g ., annotation channels 2002, 2004, 2006), or the voxels can have respective annotation sequences like the voxelized per-voxel evolutionary profiles 1700 (e.g., annotation channels 2012, 2014, 2016 (as indicated by different colors)).
  • annotation channels are voxelized, tensorized, concatenated, and processed for pathogenicity determination similar to the pan-amino acid conservation frequencies discussed with respect to Figures 12 to 18.
  • the technology disclosed can also concatenate various voxelized structural confidence channels with the distance channel tensor 700.
  • the TM-scores can be
  • the voxelized structural confidence channels are arranged voxel-wise such that the voxels can have a same structural confidence sequence like the voxelized reference allele and alternative allele sequences, or the voxels can have respective structural confidence sequences like the voxelized per-voxel evolutionary profiles 1700.
  • the structural confidence channels are voxelized, tensorized, concatenated, and processed for pathogenicity determination similar to the pan-amino acid conservation frequencies discussed with respect to Figures 12 to 18.
  • Figure 21 illustrates different combinations and permutations of input channels that can be provided as inputs 2102 to a pathogenicity classifier 2108 for a pathogenicity determination 2106 of a target variant.
  • One of the inputs 2102 can be distance channels 2104 generated by a distance channels generator 2272.
  • Figure 22 shows different methods of calculating the distance channels 2104.
  • the distance channels 2104 are generated based on distances 2202 between voxel centers and atoms across a plurality of atomic elements irrespective of amino acids.
  • the distances 2202 are normalized by a maximum scan radius to generate normalized distances 2202a.
  • the distance channels 2104 are generated based on distances 2212 between voxel centers and alpha-carbon atoms on an amino acid-basis. In some implementations, the distances 2212 are normalized by the maximum scan radius to generate normalized distances 2212a. In yet another implementation, the distance channels 2104 are generated based on distances 2222 between voxel centers and beta-carbon atoms on an amino acid-basis. In some implementations, the distances 2222 are normalized by the maximum scan radius to generate normalized distances 2222a. In yet another implementation, the distance channels 2104 are generated based on distances 2232 between voxel centers and side chain atoms on an amino acid-basis.
  • the distances 2232 are normalized by the maximum scan radius to generate normalized distances 2232a.
  • the distance channels 2104 are generated based on distances 2242 between voxel centers and backbone atoms on an amino acid-basis.
  • the distances 2242 are normalized by the maximum scan radius to generate normalized distances 2242a.
  • the distance channels 2104 are generated based on distances 2252 (one feature) between voxel centers and the respective nearest atoms irrespective of atom type and amino acid type.
  • the distance channels 2104 are generated based on distances 2262 (one feature) between voxel centers and atoms from non-standard amino acids.
  • the distances between the voxels and the atoms are calculated based on polar coordinates of the voxels and the atoms.
  • the polar coordinates are parameterized by angles between the voxels and the atoms.
  • this angel information is used to generate an angle channel for the voxels (i.e., independent of the distance channels).
  • angles between a nearest atom and neighboring atoms e.g ., backbone atoms
  • Another one of the inputs 2102 can be a feature 2114 indicating missing atoms within a specified radius.
  • Another one of the inputs 2102 can be one-hot encoding 2124 of the reference amino acid. Another one of the inputs 2102 can be one-hot encoding 2134 of the variant/alternative amino acid.
  • Another one of the inputs 2102 can be evolutionary channels 2144 generated by an evolutionary profiles generator 2372, shown in Figure 23.
  • the evolutionary channels 2144 can be generated based on pan-amino acid conservation frequencies 2302.
  • the evolutionary channels 2144 can be generated based on pan amino acid conservation frequencies 2312.
  • Another one of the inputs 2102 can be a feature 2154 indicating missing residue or missing evolutionary profile.
  • annotations channels 2164 generated by an annotations generator 2472, shown in Figure 24.
  • the annotations channels 2154 can be generated based on molecular processing annotations 2402.
  • the annotations channels 2154 can be generated based on regions annotations 2412.
  • the annotations channels 2154 can be generated based on sites annotations 2422.
  • the annotations channels 2154 can be generated based on Amino acid modifications annotations 2432.
  • the annotations channels 2154 can be generated based on secondary structure annotations 2442.
  • the annotations channels 2154 can be generated based on experimental information annotations 2452.
  • Another one of the inputs 2102 can be structure confidence channels 2174 generated by a structure confidence generator 2572, shown in Figure 25.
  • the structure confidence 2174 can be generated based on global model quality estimations (GMQEs) 2502.
  • the structure confidence 2174 can be generated based on qualitative model energy analysis (QMEAN) scores 2512.
  • the structure confidence 2174 can be generated based on temperature factors 2522.
  • the structure confidence 2174 can be generated based on template modeling scores 2542. Examples of the template modeling scores 2542 include minimum template modeling scores 2542a, mean template modeling scores 2542b, and maximum template modeling scores 2542c.
  • any permutation and combination of the input channels can be concatenated into an input for processing through the pathogenicity classifier 2108 for the pathogenicity determination 2106 of the target variant.
  • only a subset of the input channels may be concatenated.
  • the input channels can be concatenated in any order.
  • the input channels can be concatenated into a single tensor by a tensor generator (input encoder) 2110. This single tensor can then be provided as input to the pathogenicity classifier 2108 for the pathogenicity determination 2106 of the target variant.
  • the pathogenicity classifier 2108 uses convolutional neural networks (CNNs) with a plurality of convolution layers.
  • CNNs convolutional neural networks
  • the pathogenicity classifier 2108 uses recurrent neural networks (RNNs) such as a long short-term memory networks (LSTMs), bi-directional LSTMs (Bi-LSTMs), and gated recurrent units (GRU)s.
  • RNNs recurrent neural networks
  • LSTMs long short-term memory networks
  • Bi-LSTMs bi-directional LSTMs
  • GRU gated recurrent units
  • the pathogenicity classifier 2108 uses both the CNNs and the RNNs.
  • the pathogenicity classifier 2108 uses graph- convolutional neural networks that model dependencies in graph-structured data.
  • VAEs variational autoencoders
  • the pathogenicity classifier 2108 uses generative adversarial networks (GANs).
  • GANs generative adversarial networks
  • the pathogenicity classifier 2108 can also be a language model based, for example, on self-attention such as the one implemented by Transformers and BERTs.
  • the pathogenicity classifier 2108 can use ID convolutions, 2D convolutions, 3D convolutions, 4D convolutions, 5D convolutions, dilated or atrous convolutions, transpose convolutions, depthwise separable convolutions, pointwise convolutions, l x l convolutions, group convolutions, flattened convolutions, spatial and cross channel convolutions, shuffled grouped convolutions, spatial separable convolutions, and deconvolutions.
  • It can use one or more loss functions such as logistic regression/log loss, multi class cross-entropy/softmax loss, binary cross-entropy loss, mean-squared error loss, LI loss, L2 loss, smooth LI loss, and Huber loss. It can use any parallelism, efficiency, and compression schemes such TFRecords, compressed encoding (e.g, PNG), sharding, parallel calls for map transformation, batching, prefetching, model parallelism, data parallelism, and synchronous/asynchronous stochastic gradient descent (SGD).
  • loss functions such as logistic regression/log loss, multi class cross-entropy/softmax loss, binary cross-entropy loss, mean-squared error loss, LI loss, L2 loss, smooth LI loss, and Huber loss. It can use any parallelism, efficiency, and compression schemes such TFRecords, compressed encoding (e.g, PNG), sharding, parallel calls for map transformation, batching, prefetching, model parallelism, data parallelism, and synchronous
  • the pathogenicity classifier 2108 is trained using backpropagati on-based gradient update techniques.
  • Example gradient descent techniques that can be used for training the pathogenicity classifier 2108 include stochastic gradient descent, batch gradient descent, and mini-batch gradient descent.
  • Some examples of gradient descent optimization algorithms that can be used to train the pathogenicity classifier 2108 are Momentum, Nesterov accelerated gradient, Adagrad, Adadelta, RMSprop, Adam, AdaMax, Nadam, and AMSGrad.
  • the pathogenicity classifier 2108 can be trained by unsupervised learning, semi-supervised learning, self-learning, reinforcement learning, multitask learning, multimodal learning, transfer learning, knowledge distillation, and so on.
  • FIG. 26 shows an example processing architecture 2600 of the pathogenicity classifier 2108, in accordance with one implementation of the technology disclosed.
  • the processing architecture 2600 includes a cascade of processing modules 2606, 2610, 2614, 2618, 2622, 2626, 2630, 2634, 2638, and 2642 each of which can include ID convolutions (lxlxl CONV), 3D convolutions (3x3x3 CONV), ReLU non-linearity, and batch normalization (BN).
  • ID convolutions lxlxl CONV
  • 3D convolutions 3x3x3 CONV
  • ReLU non-linearity ReLU non-linearity
  • BN batch normalization
  • Other examples of the processing modules include fully-connected (FC) layers, a dropout layer, a flattening layer, and a final softmax layer that produces exponentially normalized scores for the target variant belonging to a benign class and a pathogenic class.
  • FC fully-connected
  • Figure 26 “64” denotes a number of convolution filters applied by a particular processing module.
  • the size of an input voxel 2602 is 15x15x15x8.
  • Figure 26 also shows respective volumetric dimensionalities of the intermediate inputs 2604, 2608, 2612, 2616, 2620, 2624, 2628, 2632, 2636, and 2640 generated by the processing architecture 2600.
  • FIG. 27 shows an example processing architecture 2700 of the pathogenicity classifier 2108, in accordance with one implementation of the technology disclosed.
  • the processing architecture 2700 includes a cascade of processing modules 2708, 2714, 2720, 2726, 2732, 2738, 2744, 2750, 2756, 2762, 2768, 2774, and 2780 such as ID convolutions (CONV ID), 3D convolutions (CONV 3D), ReLU non-linearity, and batch normalization (BN).
  • Other examples of the processing modules include fully-connected (dense) layers, a dropout layer, a flattening layer, and a final softmax layer that produces exponentially normalized scores for the target variant belonging to a benign class and a pathogenic class.
  • Figure 27 denotes a number of convolution filters applied by a particular processing module.
  • the size of an input voxel 2704 supplied by an input layer 2702 is 7x7x7x108.
  • Figure 27 also shows respective volumetric dimensionalities of the intermediate inputs 2710, 2716, 2722, 2728, 2734, 2740, 2746, 2752, 2758, 2764, 2770, 2776, and 2782 and the resulting intermediate outputs 2706, 2712, 2718, 2724, 2730, 2736, 2742, 2748, 2754, 2760, 2766, 2772, 2778, and 2784 generated by the processing architecture 2700.
  • the variant pathogenicity classifier disclosed herein makes pathogenicity predictions based on 3D protein structures and is referred to as “PrimateAI 3D.”
  • “Primate AI” is a commonly owned and previously disclosed variant pathogenicity classifier that makes pathogenicity predictions based protein sequences. Additional details about PrimateAI can be found in commonly owned US Patent Application Nos. 16/160,903; 16/160,986; 16/160,968; and 16/407,149 and in Sundaram, L. et al. Predicting the clinical impact of human mutation with deep neural networks. Nat. Genet. 50, 1161-1170 (2016).
  • Figures 28, 29, 30, and 31 use PrimateAI as a benchmark model to demonstrate PrimateAI 3D’s classification superiority over PrimateAI.
  • the performance results in Figures 28, 29, 30, and 31 are generated on the classification task of accurately distinguishing benign variants from pathogenic variants across a plurality of validation sets.
  • PrimateAI 3D is trained on training sets that are different from the plurality of validation sets.
  • PrimateAI 3D is trained on common human variants and variants from primates used as benign dataset while simulated variants based on trinucleotide context used as unlabeled or pseudo-pathogenic dataset.
  • New developmental delay disorder (new DDD) is one example of a validation set used to compare the classification accuracy of Primate AI 3D against Primate AI.
  • the new DDD validation set labels variants from individuals with DDD as pathogenic and labels the same variants from healthy relatives of the individuals with the DDD as benign.
  • a similar labelling scheme is used with an autism spectrum disorder (ASD) validation set shown in Figure 31.
  • ASD autism spectrum disorder
  • BRCA1 is another example of a validation set used to compare the classification accuracy of Primate AI 3D against Primate AI.
  • the BRCA1 validation set labels synthetically generated reference amino acid sequences simulating proteins of the BRCA1 gene as benign variants and labels synthetically altered allele amino acid sequences simulating proteins of the BRCA1 gene as pathogenic variants.
  • a similar labelling scheme is used with different validation sets of the TP53 gene, TP53S3 gene and its variants, and other genes and their variants shown in Figure 31.
  • Figure 28 identifies performance of the benchmark PrimateAI model with blue horizontal bars and performance of the disclosed PrimateAI 3D model with orange horizontal bars. Green horizontal bars depict pathogenicity predictions derived by combining respective pathogenicity predictions of the disclosed PrimateAI 3D model and the benchmark PrimateAI model.
  • enslO denotes an ensemble of ten PrimateAI 3D models, each trained with a different seed training dataset and randomly initialized with different weights and biases.
  • 7x7x7x2 depicts the size of the voxel grid used to encode the input channels during the training of the ensemble of ten PrimateAI 3D models.
  • the ensemble of ten PrimateAI 3D models respectively generates ten pathogenicity predictions, which are subsequently combined ( e.g ., by averaging) to generate a final pathogenicity prediction for the given variant.
  • This logic analogous applies to ensembles of different group sizes.
  • the y-axis has the different validation sets and the x-axis has p- values. Greater p-values, i.e., longer horizontal bars denote greater accuracy in differentiating benign variants from pathogenic variants.
  • PrimateAI 3D outperforms PrimateAI across most of the validation sets (only exception being the tp53s3_A549 validation set). That is, the orange horizontal bars for PrimateAI 3D are consistently longer than the blue horizontal bars for PrimateAI.
  • a “mean” category along the y-axis calculates the mean of the p- values determined for each of the validation sets.
  • PrimateAI 3D outperforms PrimateAI.
  • PrimateAI is represented by blue horizontal bars
  • an ensemble of twenty PrimateAI 3D models trained with a voxel grid of size 3x3x3 is represented by red horizontal bars
  • an ensemble of ten PrimateAI 3D models trained with a voxel grid of size 7x7x7 is represented by purple horizontal bars
  • an ensemble of twenty PrimateAI 3D models trained with a voxel grid of size 7x7x7 is represented by brown horizontal bars
  • an ensemble of twenty PrimateAI 3D models trained with a voxel grid of size 17x17x17 is represented by purple horizontal bars.
  • the y-axis has the different validation sets and the x-axis has p- values.
  • greater p-values i.e., longer horizontal bars denote greater accuracy in differentiating benign variants from pathogenic variants.
  • different configurations of PrimateAI 3D outperform PrimateAI across most of the validation sets. That is, the red, purple, brown, and pink horizontal bars for PrimateAI 3D are mostly longer than the blue horizontal bars for PrimateAI.
  • a “mean” category along the y-axis calculates the mean of the p- values determined for each of the validation sets.
  • the red vertical bars represent PrimateAI
  • the cyan vertical bars represent PrimateAI 3D.
  • the y-axis has p-values
  • the x-axis has the different validation sets.
  • PrimateAI 3D consistently outperforms PrimateAI across all of the validation sets. That is, the cyan vertical bars for PrimateAI 3D are always longer than the red vertical bars for PrimateAI.
  • Figure 31 identifies performance of the benchmark PrimateAI model with blue vertical bars and performance of the disclosed PrimateAI 3D model with orange vertical bars. Green vertical bars depict pathogenicity predictions derived by combining respective pathogenicity predictions of the disclosed PrimateAI 3D model and the benchmark PrimateAI model.
  • the y-axis has p-values
  • the x-axis has the different validation sets.
  • PrimateAI 3D outperforms PrimateAI across most of the validation sets (only exception being the tp53s3_A549_p53NULL_Nutlin-3 validation set). That is, the orange vertical bars for PrimateAI 3D are consistently longer than the blue vertical bars for PrimateAI.
  • the mean statistics may be biased by outliers.
  • a separate “method ranks” chart is also depicted in Figure 31. Higher rank denotes poorer classification accuracy.
  • PrimateAI 3D outperforms PrimateAI by having more counts of lower ranks 1 and 2 versus Primate AI having all 3 s.
  • Figure 32 is a flowchart illustrating an efficient voxelization process 3200 that efficiently identifies nearest atoms on a voxel-by-voxel basis.
  • the reference amino acid sequence 202 can contain different types of atoms, such as alpha-carbon atoms, beta- carbon atoms, oxygen atoms, nitrogen atoms, hydrogen atoms, and so on.
  • the distance channels can be arranged by nearest alpha-carbon atoms, nearest beta-carbon atoms, nearest oxygen atoms, nearest nitrogen atoms, nearest hydrogen atoms, and so on.
  • each of the nine voxels 514 has twenty-one amino acid-wise distance channels for nearest alpha-carbon atoms.
  • Figure 6 can be further expanded for each of the nine voxels 514 to also have twenty-one amino acid-wise distance channels for nearest beta- carbon atoms, and for each of the nine voxels 514 to also have a nearest generic atom distance channel for a nearest atom irrespective of the type of the atom and the type of the amino acid. This way, each of the nine voxels 514 can have forty -three distance channels.
  • the size of the data for 32 million voxelizations is too big to fit in main memory (e.g ., >20TB for a 15x15x15 voxel grid).
  • main memory e.g ., >20TB for a 15x15x15 voxel grid.
  • the memory footprint of the voxelization process gets too big to be stored on disk, making the voxelization process a part of the model training and not a precomputation step.
  • the technology disclosed provides an efficient voxelization process that achieves up to ⁇ 100x speedup over the runtime complexity of 0(#atoms * #voxels).
  • the disclosed efficient voxelization process reduces the runtime complexity for a single protein voxelization to 0(#atoms).
  • the disclosed efficient voxelization process reduces the runtime complexity for a single protein voxelization to 0(#atoms * #attributes).
  • the voxelization process becomes as fast as model training, shifting the computational bottleneck from voxelization back to computing neural network weights on processors such as GPUs, ASICs, TPUs, FPGAs, CGRAs, etc.
  • the runtime complexity for a single protein voxelization is 0(#atoms + voxels) and 0(#atoms * #attributes + voxels) for the case of different features or channels per voxel.
  • the “+ voxels” complexity is observed when the number of atoms is minuscule compared to the number of voxels, for example, when there is one atom in a 100x100x100 voxel grid (i.e., one million voxels per atom).
  • the runtime is dominated by the overhead of the huge number of voxels, for example, for allocating the memory for one million voxels, initialization one million voxels to zero, etc.
  • each atom e.g., each of the 828 alpha-carbon atoms and each of the 828 beta-carbon atoms
  • a voxel that contains the atom e.g, one of the nine voxels 514.
  • the term “contains” refers to the 3D atomic coordinates of the atom being located in the voxel.
  • the voxel that contains the atom is also referred to herein as “the atom-containing voxel.”
  • Figures 32B and 33 describe how a voxel that contains a particular atom is selected.
  • Figure 33 uses 2D atomic coordinates as representative of 3D atomic coordinates. Note that the voxel grid 522 is regularly spaced with each of the voxels 514 having a same step size (e.g, 1 angstrom (A) or 2 A).
  • the voxel grid 522 has magenta indices [0, 1, 2] along a first dimension (e.g, x-axis) and cyan indices [0, 1, 2] along a second dimension (e.g, y-axis).
  • the respective voxels 514 in the voxel grid 522 are identified by green voxel indices [Voxel 0, Voxel 1, Voxel 8] and by black voxel center indices [(1, 1), (1, 2), (3, 3)].
  • center coordinates of the voxel centers along the first dimension i.e., first dimension voxel coordinates
  • center coordinates of the voxel centers along the second dimension i.e., second dimension voxel coordinates
  • step 3202a (Step 1 in Figure 33), 3D atomic coordinates (1.7456, 2.14323) of the particular atom are quantized to generated quantized 3D atomic coordinates (1.7, 2.1).
  • the quantization can be achieved by rounding or truncation of bits.
  • voxel coordinates (or voxel centers or voxel center coordinates) of the voxels 514 are assigned to the quantized 3D atomic coordinates on a dimension-basis.
  • the quantized atomic coordinate 1.7 is assigned to Voxel 1 because it covers first dimension voxel coordinates ranging from 1 to 2 and is centered at 1.5 in the first dimension.
  • Voxel 1 has index 1 along the first dimension, in contrast to having index 0 along the second dimension.
  • the voxel grid 522 is traversed along the second dimension. This results in the quantized atomic coordinate 2.5 being assigned to Voxel 7 because it covers second dimension voxel coordinates ranging from 2 to 3 and is centered at 2.5 in the second dimension. Note that Voxel 7 has index 2 along the second dimension, in contrast to having index 1 along the first dimension.
  • step 3202c (Step 3 in Figure 33), dimension indices corresponding to the assigned voxel coordinates are selected. That is, for Voxel 1, index 1 is selected along the first dimension, and, for Voxel 7, index 2 is selected along the second dimension.
  • step 3202c Step 3 in Figure 33
  • an accumulated sum is generated based on position-wise weighting the selected dimension indices by powers of a radix.
  • positional numbering systems The general idea behind positional numbering systems is that a numeric value is represented through increasing powers of the radix (or base), for example, binary is base two, ternary is base three, octal is base eight, and hexadecimal is base sixteen. This is often referred to as a weighted numbering system because each position is weighted by a power of the radix.
  • the set of valid numericals for a positional numbering system is equal in size to the radix of that system.
  • decimal system there are ten digits in the decimal system, zero through nine, and three digits in the ternary system, zero, one, and two.
  • the largest valid number in a radix system is one smaller than the radix (so eight is not a valid numerical in any radix system smaller than nine). Any decimal integer can be expressed exactly in any other integral base system, and vice-versa.
  • the selected dimension indices 1 and 2 are converted to a single integer by position-wise multiplying them with respective powers of base three and summing the results of the position-wise multiplications.
  • Base three is selected here because the 3D atomic coordinates have three dimensions (although Figure 33 shows only 2D atomic coordinates along two dimensions for simplicity’s sake).
  • index 2 is positioned at the rightmost bit (i.e., the least significant bit), it is multiplied by three to the power of zero to yield two. Since index 1 is positioned at the second rightmost bit (i.e., the second least significant bit), it is multiplied by three to the power of one to yield three. This results in the accumulated sum being five.
  • step 3202e (Step 5 in Figure 33), based on the accumulated sum, a voxel index of the voxel containing the particular atom is selected. That is, the accumulated sum is interpreted as the voxel index of the voxel containing the particular atom.
  • each atom is further associated with one or more voxels that are in a neighborhood of the atom-containing voxel, also referred to herein as “neighborhood voxels.”
  • the neighborhood voxels can be selected based on being within a predefined radius of the atom-containing voxel (e.g ., 5 angstrom (A)). In other implementations, the neighborhood voxels can be selected based on being contiguously adjacent to the atom-containing voxel (e.g., top, bottom, right, left adjacent voxels).
  • a first alpha-carbon atom is associated with a first subset of voxels 3404 that includes an atom-containing voxel and neighborhood voxels for the first alpha-carbon atom.
  • a second alpha-carbon atom is associated with a second subset of voxels 3406 that includes an atom-containing voxel and neighborhood voxels for the second alpha-carbon atom.
  • each voxel is mapped to atoms to which it was associated at steps 3202 and 3212.
  • this mapping is encoded in a voxel-to-atoms mapping 3412, which is generated based on the atom-to-voxels mapping 3402 ( e.g ., by applying a voxel -based sorting key on the atom-to-voxels mapping 3402).
  • the voxel-to-atoms mapping 3412 is also referred to herein as “cell-to-elements mapping.”
  • a first voxel is mapped to a first subset of alpha-carbon atoms 3414 that includes alpha-carbon atoms associated with the first voxel at steps 3202 and 3212.
  • a second voxel is mapped to a second subset of alpha-carbon atoms 3416 that includes alpha-carbon atoms associated with the second voxel at steps 3202 and 3212.
  • Step 3232 for each voxel, distances are calculated between the voxel and atoms mapped to the voxel at step 3222.
  • Step 3232 has a runtime complexity of 0(#atoms) because distance to a particular atom is measured only once from a respective voxel to which the particular atom is uniquely mapped in the voxel-to-atoms mapping 3412. This is true when no neighboring voxels are considered. Without neighbors, the constant factor that is implied in the big-0 notation is 1. With neighbors, the big-0 notation is equal to the number of neighbors + 1 since the number of neighbors is constant for each voxel, and therefore the runtime complexity of 0(#atoms) remains true. In contrast, in Figure 35 A, distances to a particular atom are redundantly measured as many times as the number of voxels (e.g., 27 distances for a particular atom due to 27 voxels).
  • each voxel is mapped to a respective subset of the 828 atoms (not including distance calculations to neighborhood voxels), as illustrated by respective ovals for respective voxels.
  • the respective subsets are largely non overlapping, with some exceptions. Insignificant overlap exists due to some instances when multiple atoms are mapped to a same voxel, as indicated in Figure 35B by the prime symbol and the yellow overlap between the ovals. This minimal overlap has an additive effect on the runtime complexity of 0(#atoms) and not a multiplicative effect.
  • This overlap is a result of considering neighboring voxels, after determining the voxel that contains the atom. Without neighboring voxels, there can be no overlap, because an atom is only associated with one voxel. Considering neighbors, however, each neighbor could potentially be associated with the same atom (as long as there is no other atom of the same amino acid that is closer).
  • a nearest atom to the voxel is identified.
  • this identification is encoded in a voxel- to-nearest atom mapping 3422, also referred to herein as “cell-to-nearest element mapping.”
  • the first voxel is mapped to a second alpha-carbon atom as its nearest alpha-carbon atom 3424.
  • the second voxel is mapped to a thirty-first alpha-carbon atom as its nearest alpha-carbon atom 3426.
  • the atom-type and amino acid-type categorization of the atoms and the corresponding distance values are stored to generate categorized distance channels.
  • Figure 36 shows an example computer system 3600 that can be used to implement the technology disclosed.
  • Computer system 3600 includes at least one central processing unit (CPU) 3672 that communicates with a number of peripheral devices via bus subsystem 3655.
  • peripheral devices can include a storage subsystem 3610 including, for example, memory devices and a file storage subsystem 3636, user interface input devices 3638, user interface output devices 3676, and a network interface subsystem 3674.
  • the input and output devices allow user interaction with computer system 3600.
  • Network interface subsystem 3674 provides an interface to outside networks, including an interface to corresponding interface devices in other computer systems.
  • the pathogenicity classifier 2108 is communicably linked to the storage subsystem 3610 and the user interface input devices 3638.
  • User interface input devices 3638 can include a keyboard; pointing devices such as a mouse, trackball, touchpad, or graphics tablet; a scanner; a touch screen incorporated into the display; audio input devices such as voice recognition systems and microphones; and other types of input devices.
  • pointing devices such as a mouse, trackball, touchpad, or graphics tablet
  • audio input devices such as voice recognition systems and microphones
  • use of the term “input device” is intended to include all possible types of devices and ways to input information into computer system 3600.
  • User interface output devices 3676 can include a display subsystem, a printer, a fax machine, or non-visual displays such as audio output devices.
  • the display subsystem can include an LED display, a cathode ray tube (CRT), a flat-panel device such as a liquid crystal display (LCD), a projection device, or some other mechanism for creating a visible image.
  • the display subsystem can also provide a non-visual display such as audio output devices.
  • output device is intended to include all possible types of devices and ways to output information from computer system 3600 to the user or to another machine or computer system.
  • Storage subsystem 3610 stores programming and data constructs that provide the functionality of some or all of the modules and methods described herein. These software modules are generally executed by processors 3678.
  • Processors 3678 can be graphics processing units (GPUs), field-programmable gate arrays (FPGAs), application-specific integrated circuits (ASICs), and/or coarse-grained reconfigurable architectures (CGRAs).
  • GPUs graphics processing units
  • FPGAs field-programmable gate arrays
  • ASICs application-specific integrated circuits
  • CGRAs coarse-grained reconfigurable architectures
  • Processors 3678 can be hosted by a deep learning cloud platform such as Google Cloud PlatformTM, XilinxTM, and CirrascaleTM.
  • processors 3678 include Google’s Tensor Processing Unit (TPU)TM, rackmount solutions like GX4 Rackmount SeriesTM, GX36 Rackmount SeriesTM, NVIDIA DGX-1TM, Microsoft' Stratix V FPGATM, Graphcore's Intelligent Processor Unit (IPU)TM, Qualcomm’s Zeroth PlatformTM with Snapdragon processorsTM, NVIDIA’ s VoltaTM, NVIDIA’ s DRIVE PXTM, NVIDIA’ s JETSON TX1/TX2 MODULETM, Intel’s NirvanaTM, Movidius VPUTM, Fujitsu DPITM, ARM’s DynamicIQTM, IBM TrueNorthTM, Lambda GPU Server with Testa VI 00sTM, and others.
  • TPU Tensor Processing Unit
  • rackmount solutions like GX4 Rackmount SeriesTM, GX36 Rackmount SeriesTM, NVIDIA DGX-1TM, Microsoft' Stratix V FPGATM, Graphcore's Intelligent Processor Unit (IPU)TM
  • Memory subsystem 3622 used in the storage subsystem 3610 can include a number of memories including a main random access memory (RAM) 3632 for storage of instructions and data during program execution and a read only memory (ROM) 3634 in which fixed instructions are stored.
  • a file storage subsystem 3636 can provide persistent storage for program and data files, and can include a hard disk drive, a floppy disk drive along with associated removable media, a CD-ROM drive, an optical drive, or removable media cartridges.
  • the modules implementing the functionality of certain implementations can be stored by file storage subsystem 3636 in the storage subsystem 3610, or in other machines accessible by the processor.
  • Bus subsystem 3655 provides a mechanism for letting the various components and subsystems of computer system 3600 communicate with each other as intended. Although bus subsystem 3655 is shown schematically as a single bus, alternative implementations of the bus subsystem can use multiple busses.
  • Computer system 3600 itself can be of varying types including a personal computer, a portable computer, a workstation, a computer terminal, a network computer, a television, a mainframe, a server farm, a widely -distributed set of loosely networked computers, or any other data processing system or user device. Due to the ever-changing nature of computers and networks, the description of computer system 3600 depicted in Figure 36 is intended only as a specific example for purposes of illustrating the preferred implementations of the present invention. Many other configurations of computer system 3600 are possible having more or less components than the computer system depicted in Figure 36.
  • a system comprises memory storing amino acid-wise distance channels for a plurality of amino acids in a protein.
  • Each of the amino acid-wise distance channels has voxel-wise distance values for voxels in a plurality of voxels.
  • the voxel- wise distance values specify distances from corresponding voxels in the plurality of voxels to atoms of corresponding amino acids in the plurality of amino acids.
  • the system further comprises a pathogenicity determination engine configured to process a tensor that includes the amino acid-wise distance channels and an alternative allele of the protein expressed by a variant.
  • the pathogenicity determination engine can also be configured to determine a pathogenicity of the variant based at least in part on the tensor.
  • the system further comprises a distance channels generator that centers a voxel grid of the voxels on an alpha-carbon atom of respective residues of the amino acids.
  • the distance channels generator can center the voxel grid on an alpha-carbon atom of a residue of a particular amino acid that positioned at a variant amino acid in the protein.
  • the system can be configured to encode, in the tensor, a directionality of the amino acids and a position of the particular amino acid by multiplying, with a directionality parameter, voxel-wise distance values for those amino acids that precede the particular amino acid.
  • the distances can be nearest-atom distances from corresponding voxel centers in the voxel grid to nearest atoms of the corresponding amino acids.
  • the nearest-atom distances can be Euclidean distances.
  • the nearest-atom distances can be normalized by dividing the Euclidean distances with a maximum nearest-atom distance.
  • the amino acids can have alpha- carbon atoms and, in some implementations, the distances can be nearest-alpha-carbon atom distances from the corresponding voxel centers to nearest alpha-carbon atoms of the corresponding amino acids.
  • the amino acids can have beta-carbon atoms and, in some implementations, the distances can be nearest-beta-carbon atom distances from the corresponding voxel centers to nearest beta-carbon atoms of the corresponding amino acids.
  • the amino acids can have backbone atoms and, in some implementations, the distances can be nearest-backbone atom distances from the corresponding voxel centers to nearest backbone atoms of the corresponding amino acids.
  • the amino acids have side chain atoms and, in some implementations, the distances can be nearest-sidechain atom distances from the corresponding voxel centers to nearest sidechain atoms of the corresponding amino acids.
  • the system can further be configured to encode, in the tensor, a nearest atom channel that specifies a distance from each voxel to a nearest atom.
  • the nearest atom can be selected irrespective of the amino acids and atomic elements of the amino acids.
  • the distance is a Euclidean distance. The distance can be normalized by dividing the Euclidean distance with a maximum distance.
  • the amino acids can include non standard amino acids.
  • the tensor can include an absentee atom channel that specifies atoms not found within a predefined radius of a voxel center, and the absentee atom channel can be one-hot encoded. In some implementations, the tensor can further include a one-hot encoding of the alternative allele that is voxel-wise encoded to each of the amino acid-wise distance channels. The tensor can further include a reference allele of the protein. In some implementations, the tensor can further include a one-hot encoding of the reference allele that is voxel-wise encoded to each of the amino acid-wise distance channels. The tensor can further include evolutionary profiles that specify conservation levels of the amino acids across a plurality of species.
  • the system can further comprise an evolutionary profiles generator that, for each of the voxels, selects a nearest atom across the amino acids and the atom categories, selects a pan amino acid conservation frequencies sequence for a residue of an amino acid that includes the nearest atom, and makes the pan-amino acid conservation frequencies sequence available as one of the evolutionary profiles.
  • the pan-amino acid conservation frequencies sequence can be configured for a particular position of the residue as observed in the plurality of species.
  • the pan-amino acid conservation frequencies sequence can specify whether there is a missing conservation frequency for a particular amino acid.
  • the evolutionary profiles generator for each of the voxels, can select respective nearest atoms in respective ones of the amino acids, can select respective per-amino acid conservation frequencies for respective residues of the amino acids that include the nearest atoms, and can make the per-amino acid conservation frequencies available as one of the evolutionary profiles.
  • the per-amino acid conservation frequencies can be configured for a particular position of the residues as observed in the plurality of species.
  • the per-amino acid conservation frequencies can specify whether there is a missing conservation frequency for a particular amino acid.
  • the tensor can further include annotation channels for the amino acids.
  • the annotation channels can be one-hot encoded in the tensor.
  • the annotation channels can be molecular processing annotations that include initiator methionine, signal, transit peptide, propeptide, chain, and peptide.
  • the annotation channels can be regions annotations that include topological domain, transmembrane, intramembrane, domain, repeat, calcium binding, zinc finger, deoxyribonucleic acid (DNA) binding, nucleotide binding, region, coiled coil, motif, and compositional bias.
  • the annotation channels can be sites annotations that include active site, metal binding, binding site, and site.
  • the annotation channels can be amino acid modifications annotations that include non-standard residue, modified residue, lipidation, glycosylation, disulfide bond, and cross-link.
  • the annotation channels can be secondary structure annotations that include helix, turn, and beta strand.
  • the annotation channels can be experimental information annotations that include mutagenesis, sequence uncertainty, sequence conflict, non-adjacent residues, and non-terminal residue.
  • the tensor further includes structure confidence channels for the amino acids that specify quality of respective structures of the amino acids.
  • the structure confidence channels can be global model quality estimations (GMQEs).
  • the structure confidence channels can include qualitative model energy analysis (QMEAN) scores.
  • the structure confidence channels can be temperature factors that specify a degree to which the residues satisfy physical constraints of respective protein structures.
  • the structure confidence channels can be template structures alignments that specify a degree to which residues of atoms nearest to the voxels have aligned template structures.
  • the structure confidence channels can be template modeling scores of the aligned template structures.
  • the structure confidence channels can be a minimum one of the template modeling scores, a mean of the template modeling scores, and a maximum one of the template modeling scores.
  • the system can further comprise a tensor generator that voxel-wise concatenates amino acid-wise distance channels for the alpha-carbon atoms with the one-hot encoding of the alternative allele to generate the tensor.
  • the tensor generator can voxel- wise concatenate amino acid-wise distance channels for the beta-carbon atoms with the one-hot encoding of the alternative allele to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid- wise distance channels for the beta-carbon atoms, and the one-hot encoding of the alternative allele to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid- wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, and pan-amino acid conservation frequencies to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the pan-amino acid conservation frequencies, and the annotation channels to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the pan-amino acid conservation frequencies, the annotation channels, and the structure confidence channels to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid- wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, and per-amino acid conservation frequencies for each of the amino acids to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one- hot encoding of the alternative allele, per-amino acid conservation frequencies for each of the amino acids, and the annotation channels to generate the tensor.
  • the tensor generator can voxel- wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, per-amino acid conservation frequencies for each of the amino acids, the annotation channels, and the structure confidence channels to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, and the one-hot encoding of the reference allele to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha- carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the one-hot encoding of the reference allele, and the pan-amino acid conservation frequencies to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid- wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the one-hot encoding of the reference allele, the pan-amino acid conservation frequencies, and the annotation channels to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the one-hot encoding of the reference allele, the pan-amino acid conservation frequencies, the annotation channels, and the structure confidence channels to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the one-hot encoding of the reference allele, and the per-amino acid conservation frequencies for each of the amino acids to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha-carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the one-hot encoding of the reference allele, the per-amino acid conservation frequencies for each of the amino acids, and the annotation channels to generate the tensor.
  • the tensor generator can voxel-wise concatenate the amino acid-wise distance channels for the alpha- carbon atoms, the amino acid-wise distance channels for the beta-carbon atoms, the one-hot encoding of the alternative allele, the one-hot encoding of the reference allele, the per-amino acid conservation frequencies for each of the amino acids, the annotation channels, and the structure confidence channels to generate the tensor.
  • the system can further comprise an atoms rotation engine that rotates atoms of the amino acids before the amino acid-wise distance channels are generated.
  • the pathogenicity determination engine can be a neural network.
  • the pathogenicity determination engine can be a convolutional neural network.
  • the convolutional neural network can use l x l x l convolutions, 3 x 3 x 3 convolutions, rectified linear unit activation layers, batch normalization layers, a fully-connected layer, a dropout regularization layer, and a softmax classification layer.
  • the l x l x l convolutions and the 3 x 3 x 3 convolutions can be three-dimensional convolutions.
  • a layer of the 1 x 1 x 1 convolutions can process the tensor and produce an intermediate output that is a convolved representation of the tensor.
  • a sequence of layers of the 3 x 3 x 3 convolutions can process the intermediate output and produce a flattened output.
  • the fully-connected layer can process the flattened output and produce unnormalized outputs.
  • the softmax classification layer can process the unnormalized outputs and produce exponentially normalized outputs that identify likelihoods of the variant being pathogenic and benign.
  • a sigmoid layer can process the unnormalized outputs and produce a normalized output that identifies a likelihood of the variant being pathogenic.
  • the voxels, the atoms, and the distances can have three-dimensional coordinates.
  • the tensor can have at least three dimensions
  • the intermediate output can have at least three dimensions
  • the flattened output can have one dimension.
  • the pathogenicity determination engine is a recurrent neural network. In other implementations, the pathogenicity determination engine is an attention-based neural network. In still other implementations, the pathogenicity determination engine is a gradient-boosted tree. In still other implementations, the pathogenicity determination engine is a state vector machine.
  • a system can comprise memory storing atom category-wise distance channels for amino acids in a protein.
  • the amino acids can have atoms for a plurality of atom categories, and atom categories in the plurality of atom categories can specify atomic elements of the amino acids.
  • the atom category -wise distance channels can have voxel-wise distance values for voxels in a plurality of voxels.
  • the voxel-wise distance values can specify distances from corresponding voxels in the plurality of voxels to atoms in corresponding atom categories in the plurality of atom categories.
  • the system can further comprise a pathogenicity determination engine configured to process a tensor that includes the atom category -wise distance channels and an alternative allele of the protein expressed by a variant, and to determine a pathogenicity of the variant based at least in part on the tensor.
  • a pathogenicity determination engine configured to process a tensor that includes the atom category -wise distance channels and an alternative allele of the protein expressed by a variant, and to determine a pathogenicity of the variant based at least in part on the tensor.
  • the system can further comprise a distance channels generator that centers a voxel grid of the voxels on respective atoms of respective atom categories in the plurality of atom categories.
  • the distance channels generator can center the voxel grid on an alpha-carbon atom of a residue of at least one variant amino acid in the protein.
  • the distances can be nearest-atom distances from corresponding voxel centers in the voxel grid to nearest atoms in the corresponding atom categories.
  • the nearest-atom distances can be Euclidean distances.
  • the nearest-atom distances can be normalized by dividing the Euclidean distances with a maximum nearest-atom distances.
  • the distances can be nearest-atom distances from the corresponding voxel centers in the voxel grid to nearest atoms irrespective of the amino acids and the atom categories of the amino acids.
  • the nearest-atom distances can be Euclidean distances.
  • the nearest-atom distances can be normalized by dividing the Euclidean distances with a maximum nearest-atom distances.
  • implementations of the method described in this section can include a non- transitory computer readable storage medium storing instructions executable by a processor to perform any of the methods described above.
  • implementations of the method described in this section can include a system including memory and one or more processors operable to execute instructions, stored in the memory, to perform any of the methods described above.
  • a computer-implemented method comprising: storing amino acid-wise distance channels for a plurality of amino acids in a protein, wherein each of the amino acid-wise distance channels has voxel-wise distance values for voxels in a plurality of voxels, and wherein the voxel-wise distance values specify distances from corresponding voxels in the plurality of voxels to atoms of corresponding amino acids in the plurality of amino acids; processing a tensor that includes the amino acid-wise distance channels and an alternative allele of the protein expressed by a variant; and determining a pathogenicity of the variant based at least in part on the tensor.
  • pan-amino acid conservation frequencies sequence is configured for a particular position of the residue as observed in the plurality of species.
  • pan-amino acid conservation frequencies sequence specifies whether there is a missing conservation frequency for a particular amino acid.
  • annotation channels are molecular processing annotations that include initiator methionine, signal, transit peptide, propeptide, chain, and peptide.
  • annotation channels are regions annotations that include topological domain, transmembrane, intramembrane, domain, repeat, calcium binding, zinc finger, deoxyribonucleic acid (DNA) binding, nucleotide binding, region, coiled coil, motif, and compositional bias.
  • annotation channels are sites annotations that include active site, metal binding, binding site, and site.
  • annotation channels are amino acid modifications annotations that include non-standard residue, modified residue, lipidation, glycosylation, disulfide bond, and cross-link.
  • annotation channels are secondary structure annotations that include helix, turn, and beta strand.
  • annotation channels are experimental information annotations that include mutagenesis, sequence uncertainty, sequence conflict, non-adjacent residues, and non-terminal residue.
  • the structure confidence channels are template structures alignments that specify a degree to which residues of atoms nearest to the voxels have aligned template structures.
  • the structure confidence channels are a minimum one of the template modeling scores, a mean of the template modeling scores, and a maximum one of the template modeling scores.
  • a computer-implemented method comprising: storing atom category-wise distance channels for amino acids in a protein, wherein the amino acids have atoms for a plurality of atom categories, wherein atom categories in the plurality of atom categories specify atomic elements of the amino acids, wherein each of the atom category -wise distance channels has voxel-wise distance values for voxels in a plurality of voxels, and wherein the voxel -wise distance values specify distances from corresponding voxels in the plurality of voxels to atoms in corresponding atom categories in the plurality of atom categories; processing a tensor that includes the atom category-wise distance channels and an alternative allele of the protein expressed by a variant; and determining a pathogenicity of the variant based at least in part on the tensor.
  • One or more computer-readable media storing computer-executable instructions that, when executed on one or more processors, configure a computer to perform operations comprising: storing amino acid-wise distance channels for a plurality of amino acids in a protein, wherein each of the amino acid-wise distance channels has voxel-wise distance values for voxels in a plurality of voxels, and wherein the voxel-wise distance values specify distances from corresponding voxels in the plurality of voxels to atoms of corresponding amino acids in the plurality of amino acids; processing a tensor that includes the amino acid-wise distance channels and an alternative allele of the protein expressed by a variant; and determining a pathogenicity of the variant based at least in part on the tensor.
  • pan-amino acid conservation frequencies sequence is configured for a particular position of the residue as observed in the plurality of species.
  • pan-amino acid conservation frequencies sequence specifies whether there is a missing conservation frequency for a particular amino acid.
  • annotation channels are molecular processing annotations that include initiator methionine, signal, transit peptide, propeptide, chain, and peptide.
  • annotation channels are regions annotations that include topological domain, transmembrane, intramembrane, domain, repeat, calcium binding, zinc finger, deoxyribonucleic acid (DNA) binding, nucleotide binding, region, coiled coil, motif, and compositional bias.
  • annotation channels are sites annotations that include active site, metal binding, binding site, and site.
  • annotation channels are amino acid modifications annotations that include non-standard residue, modified residue, lipidation, glycosylation, disulfide bond, and cross-link.
  • annotation channels are secondary structure annotations that include helix, turn, and beta strand.
  • annotation channels are experimental information annotations that include mutagenesis, sequence uncertainty, sequence conflict, non-adjacent residues, and non-terminal residue.
  • QMEAN qualitative model energy analysis
  • One or more computer-readable media storing computer-executable instructions that, when executed on one or more processors, configure a computer to perform operations comprising: storing atom category-wise distance channels for amino acids in a protein, wherein the amino acids have atoms for a plurality of atom categories, wherein atom categories in the plurality of atom categories specify atomic elements of the amino acids, wherein each of the atom category -wise distance channels has voxel-wise distance values for voxels in a plurality of voxels, and wherein the voxel -wise distance values specify distances from corresponding voxels in the plurality of voxels to atoms in corresponding atom categories in the plurality of atom categories; processing a tensor that includes the atom category-wise distance channels and an alternative allele of the protein expressed by a variant; and determining a pathogenicity of the variant based at least in part on the tensor.
  • a system comprises a voxelizer that accesses a three- dimensional structure of a reference amino acid sequence of a protein and fits a three- dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate amino acid-wise distance channels.
  • Each of the amino acid-wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels.
  • the three-dimensional distance value specifies a distance from a corresponding voxel in the three- dimensional grid of voxels to atoms of a corresponding reference amino acid in the reference amino acid sequence.
  • the system further comprises an alternative allele encoder that encodes an alternative allele amino acid to each voxel in the three-dimensional grid of voxels.
  • the alternative allele amino acid is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide.
  • the system further comprises an evolutionary conservation encoder that encodes an evolutionary conservation sequence to each voxel in the three-dimensional grid of voxels.
  • the evolutionary conservation sequence can be a three-dimensional representation of amino acid-specific conservation frequencies across a plurality of species.
  • the amino acid-specific conservation frequencies can be selected in dependence upon amino acid proximity to the corresponding voxel.
  • the system further comprises a convolutional neural network configured to apply three-dimensional convolutions to a tensor that includes the amino acid-wise distance channels encoded with the alternative allele amino acid and respective evolutionary conservation sequences.
  • the convolutional neural network can be also configured to determine a pathogenicity of the variant nucleotide based at least in part on the tensor.
  • the voxelizer can center the three-dimensional grid of voxels on an alpha-carbon atom of respective residues of reference amino acids in the reference amino acid sequence.
  • the voxelizer can center the three-dimensional grid of voxels on an alpha-carbon atom of a residue of a particular reference amino acid positioned at the variant amino acid.
  • the system can be further configured to encode, in the tensor, a directionality of the reference amino acids in the reference amino acid sequence and a position of the particular reference amino acid by multiplying, with a directionality parameter, three-dimensional distance values for those reference amino acids that precede the particular reference amino acid.
  • the distances can be nearest-atom distances from corresponding voxel centers in the three-dimensional grid of voxels to nearest atoms of the corresponding reference amino acids.
  • the nearest-atom distances can be Euclidean distances and can be normalized by dividing the Euclidean distances with a maximum nearest-atom distance.
  • the reference amino acids can have alpha-carbon atoms and the distances can be nearest-alpha-carbon atom distances from the corresponding voxel centers to nearest alpha-carbon atoms of the corresponding reference amino acids.
  • the reference amino acids can have beta-carbon atoms and the distances can be nearest-beta-carbon atom distances from the corresponding voxel centers to nearest beta-carbon atoms of the corresponding reference amino acids.
  • the reference amino acids can have backbone atoms and the distances can be nearest-backbone atom distances from the corresponding voxel centers to nearest backbone atoms of the corresponding reference amino acids.
  • the amino acids can have sidechain atoms and the distances can be nearest-sidechain atom distances from the corresponding voxel centers to nearest sidechain atoms of the corresponding reference amino acids.
  • the system can be further configured to encode, in the tensor, a nearest atom channel that specifies a distance from each voxel to a nearest atom.
  • the nearest atom can be selected irrespective of the amino acids and atomic elements of the amino acids.
  • the distance can be a Euclidean distance and can be normalized by dividing the Euclidean distance with a maximum distance.
  • the amino acids can include non-standard amino acids.
  • the tensor can further include an absentee atom channel that specifies atoms not found within a predefined radius of a voxel center. The absentee atom channel can be one-hot encoded.
  • the system can further comprise a reference allele encoder that voxel-wise encodes a reference allele amino acid to each three-dimensional distance value on the amino acid position-basis.
  • the reference allele amino acid can be a three-dimensional representation of a one-hot encoding of the reference amino acid sequence.
  • the amino acid- specific conservation frequencies can specify conservation levels of respective amino acids across the plurality of species.
  • the evolutionary conservation encoder can select a nearest atom to the corresponding voxel across the reference amino acids and the atom categories, can select pan-amino acid conservation frequencies for a residue of a reference amino acid that includes the nearest atom, and can use a three-dimensional representation of the pan-amino acid conservation frequencies as the evolutionary conservation sequence.
  • the pan-amino acid conservation frequencies can be configured for a particular position of the residue as observed in the plurality of species.
  • the pan-amino acid conservation frequencies can specify whether there is a missing conservation frequency for a particular reference amino acid.
  • the evolutionary conservation encoder can select respective nearest atoms to the corresponding voxel in respective ones of the reference amino acids, can select respective per-amino acid conservation frequencies for respective residues of the reference amino acids that include the nearest atoms, and can use a three-dimensional representation of the per-amino acid conservation frequencies as the evolutionary conservation sequence.
  • the per- amino acid conservation frequencies can be configured for a particular position of the residues as observed in the plurality of species.
  • the per-amino acid conservation frequencies can specify whether there is a missing conservation frequency for a particular reference amino acid.
  • the system can further comprise an annotations encoder that voxel-wise encodes one or more annotation channels to each three-dimensional distance value.
  • the annotation channels can be three-dimensional representations of a one-hot encoding of residue annotations and can be molecular processing annotations that include initiator methionine, signal, transit peptide, propeptide, chain, and peptide.
  • the annotation channels can be regions annotations that include topological domain, transmembrane, intramembrane, domain, repeat, calcium binding, zinc finger, deoxyribonucleic acid (DNA) binding, nucleotide binding, region, coiled coil, motif, and compositional bias or can be sites annotations that include active site, metal binding, binding site, and site.
  • the annotation channels can be amino acid modifications annotations that include non-standard residue, modified residue, lipidation, glycosylation, disulfide bond, and cross-link or can be secondary structure annotations that include helix, turn, and beta strand.
  • the annotation channels can be experimental information annotations that include mutagenesis, sequence uncertainty, sequence conflict, non-adjacent residues, and non-terminal residue.
  • the system can further comprise a structure confidence encoder that voxel-wise encodes one or more structure confidence channels to each three- dimensional distance value.
  • the structure confidence channels can be three-dimensional representations of confidence scores that specify quality of respective residue structures.
  • the structure confidence channels can be global model quality estimations (GMQEs), can be qualitative model energy analysis (QMEAN) scores, can be temperature factors that specify a degree to which the residues satisfy physical constraints of respective protein structures, can be template structures alignments that specify a degree to which residues of atoms nearest to the voxels have aligned template structures, can be template modeling scores of the aligned template structures, or can be a minimum one of the template modeling scores, a mean of the template modeling scores, and a maximum one of the template modeling scores.
  • GQEs global model quality estimations
  • QMEAN qualitative model energy analysis
  • the system can further comprise an atoms rotation engine that rotates the atoms before the amino acid-wise distance channels are generated.
  • the convolutional neural network can use l x l x l convolutions, 3 x 3 x 3 convolutions, rectified linear unit activation layers, batch normalization layers, a fully-connected layer, a dropout regularization layer, and a softmax classification layer.
  • the l x l x l convolutions and the 3 x 3 x 3 convolutions can be the three-dimensional convolutions.
  • a layer of the 1 x 1 x 1 convolutions can process the tensor and produce an intermediate output that is a convolved representation of the tensor.
  • a sequence of layers of the 3 x 3 x 3 convolutions can process the intermediate output and produce a flattened output.
  • the fully-connected layer can process the flattened output and produce unnormalized outputs.
  • the softmax classification layer can process the unnormalized outputs and produce exponentially normalized outputs that identify likelihoods of the variant nucleotide being pathogenic and benign.
  • a sigmoid layer can process the unnormalized outputs and produce a normalized output that identifies a likelihood of the variant nucleotide being pathogenic.
  • the convolutional neural network can be an attention-based neural network.
  • the tensor can include the amino acid-wise distance channels further encoded with the reference allele amino acid, can include the amino acid-wise distance channels further encoded with the annotation channels, or can include the amino acid-wise distance channels further encoded with the structure confidence channels.
  • a system can comprise a voxelizer that accesses a three- dimensional structure of a reference amino acid sequence of a protein and fits a three- dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate atom category-wise distance channels.
  • the atoms span a plurality of atom categories, which specify atomic elements of the amino acids.
  • Each of the atom category -wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels.
  • the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of corresponding atom categories in the plurality of atom categories.
  • the system further comprises an alternative allele encoder that encodes an alternative allele amino acid to each voxel in the three-dimensional grid of voxels.
  • the alternative allele amino acid is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide.
  • the system further comprises an evolutionary conservation encoder that encodes an evolutionary conservation sequence to each voxel in the three-dimensional grid of voxels.
  • the evolutionary conservation sequence can be a three-dimensional representation of amino acid-specific conservation frequencies across a plurality of species.
  • the amino acid-specific conservation frequencies can be selected in dependence upon amino acid proximity to the corresponding voxel.
  • the system further comprises a convolutional neural network configured to apply three-dimensional convolutions to a tensor that includes the atom category -wise distance channels encoded with the alternative allele amino acid and respective evolutionary conservation sequences, and to determine a pathogenicity of the variant nucleotide based at least in part on the tensor.
  • a system comprises a voxelizer that accesses a three- dimensional structure of a reference amino acid sequence of a protein and fits a three- dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate amino acid-wise distance channels.
  • Each of the amino acid-wise distance channels can have a three-dimensional distance value for each voxel in the three-dimensional grid of voxels.
  • the three-dimensional distance value can specify a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of a corresponding reference amino acid in the reference amino acid sequence.
  • the system further comprises an alternative allele encoder that encodes an alternative allele amino acid to each voxel in the three-dimensional grid of voxels.
  • the alternative allele amino acid is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide.
  • the system further comprises an evolutionary conservation encoder that encodes an evolutionary conservation sequence to each voxel in the three-dimensional grid of voxels.
  • the evolutionary conservation sequence can be a three-dimensional representation of amino acid-specific conservation frequencies across a plurality of species.
  • the amino acid-specific conservation frequencies can be selected in dependence upon amino acid proximity to the corresponding voxel.
  • the system further comprises a tensor generator configured to generate a tensor that includes the amino acid-wise distance channels encoded with the alternative allele amino acid and respective evolutionary conservation sequences.
  • a system comprises a voxelizer that accesses a three- dimensional structure of a reference amino acid sequence of a protein and fits a three- dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate atom category-wise distance channels.
  • the atoms can span a plurality of atom categories, which specify atomic elements of the amino acids.
  • Each of the atom category-wise distance channels can have a three-dimensional distance value for each voxel in the three- dimensional grid of voxels.
  • the three-dimensional distance value can specify a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of corresponding atom categories in the plurality of atom categories.
  • the system further comprises an alternative allele encoder that encodes an alternative allele amino acid to each voxel in the three-dimensional grid of voxels.
  • the alternative allele amino acid is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide.
  • the system further comprises an evolutionary conservation encoder that encodes an evolutionary conservation sequence to each voxel in the three-dimensional grid of voxels.
  • the evolutionary conservation sequence can be a three-dimensional representation of amino acid-specific conservation frequencies across a plurality of species.
  • the amino acid-specific conservation frequencies can be selected in dependence upon amino acid proximity to the corresponding voxel.
  • the system further comprises a tensor generator configured to generate a tensor that includes the atom category -wise distance channels encoded with the alternative allele amino acid and respective evolutionary conservation sequences.
  • a computer-implemented method comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate amino acid-wise distance channels, wherein each of the amino acid-wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of a corresponding reference amino acid in the reference amino acid sequence; encoding an alternative allele channel to each voxel in the three-dimensional grid of voxels, wherein the alternative allele channel is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide; encoding an evolutionary conservation channel to each sequence of three-dimensional distance values across the amino acid-wise distance channels on
  • the reference allele amino acid is a three-dimensional representation of a one-hot encoding of a reference amino acid that experiences the variant amino acid.
  • pan-amino acid conservation frequencies are configured for a particular position of the residue as observed in the plurality of species.
  • pan-amino acid conservation frequencies specify whether there is a missing conservation frequency for a particular reference amino acid.
  • annotation channels are molecular processing annotations that include initiator methionine, signal, transit peptide, propeptide, chain, and peptide.
  • annotation channels are regions annotations that include topological domain, transmembrane, intramembrane, domain, repeat, calcium binding, zinc finger, deoxyribonucleic acid (DNA) binding, nucleotide binding, region, coiled coil, motif, and compositional bias.
  • annotation channels are sites annotations that include active site, metal binding, binding site, and site.
  • annotation channels are amino acid modifications annotations that include non-standard residue, modified residue, lipidation, glycosylation, disulfide bond, and cross-link.
  • annotation channels are secondary structure annotations that include helix, turn, and beta strand.
  • annotation channels are experimental information annotations that include mutagenesis, sequence uncertainty, sequence conflict, non-adjacent residues, and non-terminal residue.
  • the structure confidence channels are template structures alignments that specify a degree to which residues of atoms nearest to the voxels have aligned template structures.
  • the structure confidence channels are a minimum one of the template modeling scores, a mean of the template modeling scores, and a maximum one of the template modeling scores.
  • a computer-implemented method comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate atom category -wise distance channels, wherein the atoms span a plurality of atom categories, wherein atom categories in the plurality of atom categories specify atomic elements of the amino acids, wherein each of the atom category -wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of corresponding atom categories in the plurality of atom categories; encoding an alternative allele channel to each voxel in the three-dimensional grid of voxels, wherein the alternative allele channel is a three-dimensional representation of a one-hot en
  • a computer-implemented method comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate amino acid-wise distance channels, wherein each of the amino acid-wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of a corresponding reference amino acid in the reference amino acid sequence; encoding an alternative allele channel to each voxel in the three-dimensional grid of voxels, wherein the alternative allele channel is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide; encoding an evolutionary conservation channel to each sequence of three-dimensional distance values across the amino acid-wise distance channels
  • a computer-implemented method comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate atom category -wise distance channels, wherein the atoms span a plurality of atom categories, wherein atom categories in the plurality of atom categories specify atomic elements of the amino acids, wherein each of the atom category -wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of corresponding atom categories in the plurality of atom categories; encoding an alternative allele channel to each voxel in the three-dimensional grid of voxels, wherein the alternative allele channel is a three-dimensional representation of a one-hot en
  • One or more computer-readable media storing computer-executable instructions that, when executed on one or more processors, configure a computer to perform operations comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate amino acid-wise distance channels, wherein each of the amino acid-wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of a corresponding reference amino acid in the reference amino acid sequence; encoding an alternative allele channel to each voxel in the three-dimensional grid of voxels, wherein the alternative allele channel is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by a variant nucleotide;
  • the computer-readable media of clause 1 the operations further comprising voxel-wise encoding a reference allele channel to each voxel in the three-dimensional grid of voxels.
  • the reference allele amino acid is a three- dimensional representation of a one-hot encoding of a reference amino acid that experiences the variant amino acid.
  • pan-amino acid conservation frequencies are configured for a particular position of the residue as observed in the plurality of species.
  • pan-amino acid conservation frequencies specify whether there is a missing conservation frequency for a particular reference amino acid.
  • annotation channels are molecular processing annotations that include initiator methionine, signal, transit peptide, propeptide, chain, and peptide.
  • annotation channels are regions annotations that include topological domain, transmembrane, intramembrane, domain, repeat, calcium binding, zinc finger, deoxyribonucleic acid (DNA) binding, nucleotide binding, region, coiled coil, motif, and compositional bias.
  • annotation channels are sites annotations that include active site, metal binding, binding site, and site.
  • annotation channels are amino acid modifications annotations that include non-standard residue, modified residue, lipidation, glycosylation, disulfide bond, and cross-link.
  • annotation channels are secondary structure annotations that include helix, turn, and beta strand.
  • annotation channels are experimental information annotations that include mutagenesis, sequence uncertainty, sequence conflict, non-adjacent residues, and non-terminal residue.
  • the computer-readable media of clause 34, wherein the structure confidence channels are global model quality estimations (GMQEs). 36. The computer-readable media of clause 34, wherein the structure confidence channels are qualitative model energy analysis (QMEAN) scores.
  • GQEs global model quality estimations
  • QMEAN qualitative model energy analysis
  • One or more computer-readable media storing computer-executable instructions that, when executed on one or more processors, configure a computer to perform operations comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate atom category -wise distance channels, wherein the atoms span a plurality of atom categories, wherein atom categories in the plurality of atom categories specify atomic elements of the amino acids, wherein each of the atom category -wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of corresponding atom categories in the plurality of atom categories; encoding an alternative allele channel to each voxel in the three-dimensional grid of vo
  • One or more computer-readable media storing computer-executable instructions that, when executed on one or more processors, configure a computer to perform operations comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate amino acid-wise distance channels, wherein each of the amino acid-wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of a corresponding reference amino acid in the reference amino acid sequence; encoding an alternative allele channel to each three-dimensional distance value in each of the amino acid-wise distance channels on an amino acid position-basis, wherein the alternative allele channel is a three-dimensional representation of a one-hot encoding of a variant amino acid expressed by
  • One or more computer-readable media storing computer-executable instructions that, when executed on one or more processors, configure a computer to perform operations comprising: accessing a three-dimensional structure of a reference amino acid sequence of a protein, and fitting a three-dimensional grid of voxels on atoms in the three-dimensional structure on an amino acid-basis to generate atom category -wise distance channels, wherein the atoms span a plurality of atom categories, wherein atom categories in the plurality of atom categories specify atomic elements of the amino acids, wherein each of the atom category -wise distance channels has a three-dimensional distance value for each voxel in the three-dimensional grid of voxels, and wherein the three-dimensional distance value specifies a distance from a corresponding voxel in the three-dimensional grid of voxels to atoms of corresponding atom categories in the plurality of atom categories; encoding an alternative allele channel to each voxel in the three-dimensional grid of vo
  • implementations of the method described in this section can include a non- transitory computer readable storage medium storing instructions executable by a processor to perform any of the methods described above.
  • implementations of the method described in this section can include a system including memory and one or more processors operable to execute instructions, stored in the memory, to perform any of the methods described above.
  • a computer-implemented method of efficiently determining which elements of a sequence are nearest to uniformly spaced cells in a grid, wherein the elements have element coordinates, and the cells have dimension-wise cell indices and cell coordinates including: generating an element-to-cells mapping that maps, to each of the elements, a subset of the cells, wherein the subset of the cells mapped to a particular element in the sequence includes a nearest cell in the grid and one or more neighborhood cells in the grid, wherein the nearest cell is selected based on matching element coordinates of the particular element to the cell coordinates, and wherein the neighborhood cells are contiguously adjacent to the nearest cell and selected based on being within a distance proximity range from the particular element; generating a cell-to-elements mapping that maps, to each of the cells, a subset of the elements, wherein the subset of the elements mapped to a particular cell in the grid includes those elements in the sequence that are mapped to the particular cell by the element-to-cells mapping; and using the cell-to
  • the matching the element coordinates of the particular element to the cell coordinates further includes: for a first dimension, matching a first truncated element coordinate in the truncated element coordinates to a first cell coordinate of a first cell in the grid, and selecting a first dimension index of the first cell; for a second dimension, matching a second truncated element coordinate in the truncated element coordinates to a second cell coordinate of a second cell in the grid, and selecting a second dimension index of the second cell; for a third dimension, matching a third truncated element coordinate in the truncated element coordinates to a third cell coordinate of a third cell in the grid, and selecting a third dimension index of the third cell; using the selected first, second, and third dimension indices to generate an accumulated sum based on position-wise weighting the selected first, second, and third dimension indices by powers of a radix; and using the accumulated sum as a cell index for selection of
  • a computer-implemented method of efficiently determining which atoms in a protein are nearest to voxels in a grid, wherein the atoms have three-dimensional (3D) atom coordinates, and the voxels have 3D voxel coordinates including: generating an atom -to- voxels mapping that maps, to each of the atoms, a containing voxel selected based on matching 3D atom coordinates of a particular atom of the protein to the 3D voxel coordinates in the grid; generating a voxel-to-atoms mapping that maps, to each of the voxels, a subset of the atoms, wherein the subset of the atoms mapped to a particular voxel in the grid includes those atoms in the protein that are mapped to the particular voxel by the atom-to-voxels mapping; and using the voxel-to-atoms mapping to determine, for each of the vox
  • implementations of the method described in this section can include a non- transitory computer readable storage medium storing instructions executable by a processor to perform any of the methods described above.
  • implementations of the method described in this section can include a system including memory and one or more processors operable to execute instructions, stored in the memory, to perform any of the methods described above.

Landscapes

  • Engineering & Computer Science (AREA)
  • Physics & Mathematics (AREA)
  • Life Sciences & Earth Sciences (AREA)
  • Theoretical Computer Science (AREA)
  • Health & Medical Sciences (AREA)
  • Biophysics (AREA)
  • General Health & Medical Sciences (AREA)
  • Data Mining & Analysis (AREA)
  • Spectroscopy & Molecular Physics (AREA)
  • Bioinformatics & Cheminformatics (AREA)
  • Medical Informatics (AREA)
  • Molecular Biology (AREA)
  • Evolutionary Computation (AREA)
  • Artificial Intelligence (AREA)
  • Software Systems (AREA)
  • Biotechnology (AREA)
  • Evolutionary Biology (AREA)
  • Bioinformatics & Computational Biology (AREA)
  • Biomedical Technology (AREA)
  • Computational Linguistics (AREA)
  • Computing Systems (AREA)
  • General Engineering & Computer Science (AREA)
  • General Physics & Mathematics (AREA)
  • Mathematical Physics (AREA)
  • Chemical & Material Sciences (AREA)
  • Proteomics, Peptides & Aminoacids (AREA)
  • Analytical Chemistry (AREA)
  • Databases & Information Systems (AREA)
  • Computer Vision & Pattern Recognition (AREA)
  • Epidemiology (AREA)
  • Public Health (AREA)
  • Bioethics (AREA)
  • Genetics & Genomics (AREA)
  • Crystallography & Structural Chemistry (AREA)
  • Information Retrieval, Db Structures And Fs Structures Therefor (AREA)
  • Management, Administration, Business Operations System, And Electronic Commerce (AREA)
  • Investigating Or Analysing Biological Materials (AREA)
  • Image Generation (AREA)
  • Image Processing (AREA)
  • Magnetic Resonance Imaging Apparatus (AREA)

Abstract

Un système comprend au moins un dispositif de voxelisation, un codeur d'allèle de substitution, un codeur de conservation évolutive et un réseau neuronal convolutif. Le dispositif de voxelisation accède à une structure tridimensionnelle d'une séquence d'acides aminés de référence d'une protéine et s'adapte à une grille tridimensionnelle de voxels sur des atomes dans la structure tridimensionnelle sur une base d'acides aminés en vue de générer des canaux de distance en acides aminés. Le codeur d'allèle de substitution code une séquence d'allèle de substitution pour chaque voxel dans la grille tridimensionnelle de voxels. Le codeur de conservation évolutive code une séquence de conservation évolutive pour chaque voxel dans la grille tridimensionnelle de voxels. Le réseau neuronal convolutif applique des convolutions tridimensionnelles à un tenseur qui comprend les canaux de distance en acides aminés codés avec la séquence d'allèle de substitution et des séquences de conservation évolutive respectives et détermine une pathogénicité d'un variant de nucléotide sur la base, au moins en partie, du tenseur.
PCT/US2022/024916 2021-04-15 2022-04-14 Voxelisation de protéine à canaux multiples pour prédire une pathogénicité d'un variant à l'aide de réseaux neuronaux convolutifs profonds WO2022221591A1 (fr)

Priority Applications (8)

Application Number Priority Date Filing Date Title
AU2022258691A AU2022258691A1 (en) 2021-04-15 2022-04-14 Multi-channel protein voxelization to predict variant pathogenicity using deep convolutional neural networks
CN202280027967.1A CN117178327A (zh) 2021-04-15 2022-04-14 使用深度卷积神经网络来预测变体致病性的多通道蛋白质体素化
KR1020237034825A KR20230170680A (ko) 2021-04-15 2022-04-14 심층 콘볼루션 신경망들을 사용하여 변이체 병원성을 예측하기 위한 다중 채널 단백질 복셀화
BR112023021266A BR112023021266A2 (pt) 2021-04-15 2022-04-14 Voxelização de proteína de múltiplos canais para predizer a patogenicidade variante com o uso de redes neurais convolucionais profundas
IL307661A IL307661A (en) 2021-04-15 2022-04-14 Multichannel protein vocalization for variant pathogenicity prediction using deep neural networks
JP2023563033A JP2024513995A (ja) 2021-04-15 2022-04-14 深層畳み込みニューラルネットワークを使用する変異体病原性を予測するためのマルチチャネルタンパク質ボクセル化
EP22726207.8A EP4323991A1 (fr) 2021-04-15 2022-04-14 Voxelisation de protéine à canaux multiples pour prédire une pathogénicité d'un variant à l'aide de réseaux neuronaux convolutifs profonds
CA3215514A CA3215514A1 (fr) 2021-04-15 2022-04-14 Voxelisation de proteine a canaux multiples pour predire une pathogenicite d'un variant a l'aide de reseaux neuronaux convolutifs profonds

Applications Claiming Priority (8)

Application Number Priority Date Filing Date Title
US202163175495P 2021-04-15 2021-04-15
US63/175,495 2021-04-15
US202163175767P 2021-04-16 2021-04-16
US63/175,767 2021-04-16
US17/703,958 2022-03-24
US17/703,935 2022-03-24
US17/703,958 US20220336057A1 (en) 2021-04-15 2022-03-24 Efficient voxelization for deep learning
US17/703,935 US20220336056A1 (en) 2021-04-15 2022-03-24 Multi-channel protein voxelization to predict variant pathogenicity using deep convolutional neural networks

Publications (1)

Publication Number Publication Date
WO2022221591A1 true WO2022221591A1 (fr) 2022-10-20

Family

ID=81448684

Family Applications (2)

Application Number Title Priority Date Filing Date
PCT/US2022/024916 WO2022221591A1 (fr) 2021-04-15 2022-04-14 Voxelisation de protéine à canaux multiples pour prédire une pathogénicité d'un variant à l'aide de réseaux neuronaux convolutifs profonds
PCT/US2022/024918 WO2022221593A1 (fr) 2021-04-15 2022-04-14 Voxélisation efficace pour apprentissage en profondeur

Family Applications After (1)

Application Number Title Priority Date Filing Date
PCT/US2022/024918 WO2022221593A1 (fr) 2021-04-15 2022-04-14 Voxélisation efficace pour apprentissage en profondeur

Country Status (8)

Country Link
EP (2) EP4323989A1 (fr)
JP (2) JP2024514894A (fr)
KR (2) KR20230170680A (fr)
AU (2) AU2022259667A1 (fr)
BR (2) BR112023021343A2 (fr)
CA (2) CA3215514A1 (fr)
IL (2) IL307661A (fr)
WO (2) WO2022221591A1 (fr)

Families Citing this family (1)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
CN116153404B (zh) * 2023-02-28 2023-08-15 成都信息工程大学 一种单细胞ATAC-seq数据分析方法

Citations (3)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
US20190266491A1 (en) * 2017-10-16 2019-08-29 Illumina, Inc. Deep Learning-Based Techniques for Training Deep Convolutional Neural Networks
CN110245685A (zh) * 2019-05-15 2019-09-17 清华大学 基因组单位点变异致病性的预测方法、系统及存储介质
US20200342955A1 (en) * 2017-10-27 2020-10-29 Apostle, Inc. Predicting cancer-related pathogenic impact of somatic mutations using deep learning-based methods

Patent Citations (3)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
US20190266491A1 (en) * 2017-10-16 2019-08-29 Illumina, Inc. Deep Learning-Based Techniques for Training Deep Convolutional Neural Networks
US20200342955A1 (en) * 2017-10-27 2020-10-29 Apostle, Inc. Predicting cancer-related pathogenic impact of somatic mutations using deep learning-based methods
CN110245685A (zh) * 2019-05-15 2019-09-17 清华大学 基因组单位点变异致病性的预测方法、系统及存储介质

Non-Patent Citations (4)

* Cited by examiner, † Cited by third party
Title
JAGANATHAN, K. ET AL.: "Predicting splicing from primary sequence with deep learning", CELL, vol. 176, 2019, pages 535 - 548
PEI PZHANG A: "A Topological Measurement for Weighted Protein Interaction Network", CSB, 2005, pages 268 - 278, XP010831154, DOI: 10.1109/CSB.2005.8
SUNDARAM LAKSSHMAN ET AL: "Predicting the clinical impact of human mutation with deep neural networks", NATURE GENETICS, NATURE PUBLISHING GROUP US, NEW YORK, vol. 50, no. 8, 23 July 2018 (2018-07-23), pages 1161 - 1170, XP036902750, ISSN: 1061-4036, [retrieved on 20180723], DOI: 10.1038/S41588-018-0167-Z *
SUNDARAM, L. ET AL.: "Predicting the clinical impact of human mutation with deep neural networks", NAT. GENET., vol. 50, 2018, pages 1161 - 1170, XP036902750, DOI: 10.1038/s41588-018-0167-z

Also Published As

Publication number Publication date
BR112023021343A2 (pt) 2023-12-19
JP2024514894A (ja) 2024-04-03
BR112023021266A2 (pt) 2023-12-12
CA3215514A1 (fr) 2022-10-20
KR20230170680A (ko) 2023-12-19
AU2022259667A1 (en) 2023-10-26
AU2022258691A1 (en) 2023-10-26
JP2024513995A (ja) 2024-03-27
IL307667A (en) 2023-12-01
WO2022221593A1 (fr) 2022-10-20
KR20230170679A (ko) 2023-12-19
CA3215520A1 (fr) 2022-10-20
IL307661A (en) 2023-12-01
EP4323989A1 (fr) 2024-02-21
EP4323991A1 (fr) 2024-02-21

Similar Documents

Publication Publication Date Title
WO2023014912A1 (fr) Utilisation basée sur l'apprentissage de transfert de cartes de contact de protéine pour une prédiction de pathogénicité de variant
US20220336056A1 (en) Multi-channel protein voxelization to predict variant pathogenicity using deep convolutional neural networks
US11515010B2 (en) Deep convolutional neural networks to predict variant pathogenicity using three-dimensional (3D) protein structures
EP4323991A1 (fr) Voxelisation de protéine à canaux multiples pour prédire une pathogénicité d'un variant à l'aide de réseaux neuronaux convolutifs profonds
WO2022221587A1 (fr) Analyse basée sur l'intelligence artificielle de structures tridimensionnelles (3d) de protéine
US20230045003A1 (en) Deep learning-based use of protein contact maps for variant pathogenicity prediction
US20230245305A1 (en) Image-based variant pathogenicity determination
US20230047347A1 (en) Deep neural network-based variant pathogenicity prediction
US11538555B1 (en) Protein structure-based protein language models
US20230343413A1 (en) Protein structure-based protein language models
WO2023059750A1 (fr) Apprentissage combiné et par transfert d'un prédicteur de pathogénicité de variants au moyen d'échantillons de protéines à brèche et sans brèche
KR20240082270A (ko) 단백질 구조 기반의 단백질 언어 모델
US20240112751A1 (en) Copy number variation (cnv) breakpoint detection
KR20240082269A (ko) 3차원(3d) 단백질 구조 복셀을 사용하는 진화 보존으로부터의 변이체 병원성 예측
CN117178327A (zh) 使用深度卷积神经网络来预测变体致病性的多通道蛋白质体素化
CN117581302A (zh) 使用有缺口和非缺口的蛋白质样品的变体致病性预测器的组合学习和迁移学习
CN117546242A (zh) 基于蛋白质结构的蛋白质语言模型
WO2024030606A1 (fr) Détection, basée sur l'intelligence artificielle, de la conservation de gènes et du maintien de l'expression de ceux-ci à une résolution de base
KR20240041877A (ko) 변이 병원성 예측을 위한 단백질 접촉 맵의 전이학습 기반 이용

Legal Events

Date Code Title Description
121 Ep: the epo has been informed by wipo that ep was designated in this application

Ref document number: 22726207

Country of ref document: EP

Kind code of ref document: A1

WWE Wipo information: entry into national phase

Ref document number: 804359

Country of ref document: NZ

Ref document number: AU2022258691

Country of ref document: AU

Ref document number: 2022258691

Country of ref document: AU

WWE Wipo information: entry into national phase

Ref document number: 307661

Country of ref document: IL

WWE Wipo information: entry into national phase

Ref document number: 2023563033

Country of ref document: JP

Ref document number: MX/A/2023/012226

Country of ref document: MX

Ref document number: 3215514

Country of ref document: CA

REG Reference to national code

Ref country code: BR

Ref legal event code: B01A

Ref document number: 112023021266

Country of ref document: BR

ENP Entry into the national phase

Ref document number: 2022258691

Country of ref document: AU

Date of ref document: 20220414

Kind code of ref document: A

WWE Wipo information: entry into national phase

Ref document number: 2023125430

Country of ref document: RU

Ref document number: 2022726207

Country of ref document: EP

NENP Non-entry into the national phase

Ref country code: DE

ENP Entry into the national phase

Ref document number: 2022726207

Country of ref document: EP

Effective date: 20231115

ENP Entry into the national phase

Ref document number: 112023021266

Country of ref document: BR

Kind code of ref document: A2

Effective date: 20231011