Abstract
Clinical diagnosis and prognosis usually rely on few or even single measurements despite clinical big data being available. This limits the exploration of complex diseases such as adolescent idiopathic scoliosis (AIS) where the associated low bone mass remains unexplained. Observed low physical activity and increased RANKL/OPG, however, both indicate a mechanobiological cause. To deepen disease understanding, we propose an in silico prognosis approach using clinical big data, i.e. medical images, serum markers, questionnaires and live style data from mobile monitoring devices and explore the role of inadequate physical activity in a first AIS prototype. It employs a cellular automaton (CA) to represent the medical image, micro-finite element analysis to calculate loading, and a Boolean network to integrate the other biomarkers. Medical images of the distal tibia, physical activity scores, and vitamin D and PTH levels were integrated as measured clinically while the time development of bone density and RANKL/OPG was observed. Simulation of an AIS patient with normal physical activity and patient-specific vitamin D and PTH levels showed minor changes in bone density whereas the simulation of the same AIS patient but with reduced physical activity led to low density. Both showed unchanged RANKL/OPG and considerable cortical resorption. We conclude that our integrative in silico approach allows to account for a variety of clinical big data to study complex diseases.
1 Introduction
Understanding the physiology of the human body is a tremendous challenge, understanding and finally treating diseases is arguably an even more difficult task. Many diseases exhibit alterations in complex signalling pathways that lead to distinct phenotypes used in diagnosis and prognosis. However, both usually rely on few or even single clinical measurements despite clinical big data, i.e. medical images, serum markers, questionnaires and live style data from mobile monitoring devices being available. Exploiting these clinical big data would potentially enable one explore and thus further understand complex diseases such as adolescent idiopathic scoliosis (AIS) where many alterations in the signalling cascade and other factors such as a patient’s lifestyle play an essential role.
AIS is a prevalent spinal deformity associated with systemic low bone mass (Z-score ≤ −1 with the reference to local matched population), which can persist into adulthood predisposing to osteoporosis in later life. If not treated properly, the curve will deteriorate leading to cardiopulmonary compromise, back pain, degenerative spine disease, and psychosocial disorder [1]. Low bone mass has been identified as a risk factor for curve progression. The underlying mechanism of low bone mass in AIS, however, remains unknown although it would potentially provide a basis for counteracting the associated complications [2]. It has been suggested that low bone mass is related to inadequate physical activity [3] and an increase in RANKL/OPG [1], which might lead to increased bone resorption. Most recently, low vitamin D levels were observed in AIS patients [4] indicating that multiple factors play a role in AIS.
Therefore, we propose a novel prognosis approach using clinical big data for the in silico simulation of complex diseases with the ultimate goal to improve clinical diagnosis and prognosis of these diseases as well as the evaluation of treatment options. Medical images containing bone tissue density are integrated into a cellular automaton (CA) model where the tissue densities define local states. These states are updated according to a local rule that takes into account the biological cells present in each CA cell. The cell number or activity is normalised representing a normal healthy value by default but with the possibility to either initialise patient-specific or experimental values. It allows to integrate serum markers of specific cells if they are available and at the same time does not require the definition of a value if it is not known. The cells itself are updated through mechanical tissue loading as calculated with micro-finite element (micro-FE) analyses and a molecular factor determined in a Boolean network, which models the interaction of cells, molecules, and mechanical loading. The entire procedure is applied to obtain cell and tissue densities as well as molecular states at different time points that describe the time evolution of the system. Here, we describe and formulate the theoretical basis of this integrative in silico prognosis approach and present a first prototype demonstrating the integration of medical image, serum marker, and lifestyle data for AIS.
The purpose of this study is to formulate a theory for integrating varying clinical big data, and implement and employ it to simulate low bone mass typical of AIS.
2 Material and methods
We performed in silico simulations over a period of 6 months integrating high-resolution peripheral quantitative computed tomography (HR-pQCT) images of the distal tibia, physical activity scores, and vitamin D and PTH levels of an AIS patient. Two simulations were run including an AIS control case with normal physical activity score, and vitamin D and PTH levels as measured in the patient’s serum, and an AIS case with reduced physical activity as observed in other studies but again with the same patient-specific measurements as in the control simulation.
2.1 Clinical patient assessment
To validate the proposed in silico prognosis, a 17-year-old AIS girl (patient number 666; major Cobb angle 37
2.2 Cellular automaton
The medical image of a bone, e.g. a HR-pQCT scan, is a 3D representation of the bone density in a cubic domain at a certain voxel resolution. It can be regarded as the regular grid, G, of cells of a CA. For each CA cell and a given time point, t, a density value, a strain energy density (SED) value, the number or activity of the different biological cells and the presence or absence of several molecules usually found in bone are defined:
with ρ being the tissue density value, ϵ being the SED value, N the number of cell types considered, ni the number or activity of biological cells of type i inside each voxel, M the number of molecule types considered and mj indicating whether the molecule of type j is present or absent. This tuple makes up the state of this CA cell at time t. Our first prototype uses three cell types: osteoblasts (nOBL) forming new bone tissue and osteoclasts (nOCL) removing old bone tissue resulting in a continuous remodelling of the tissue, and osteocytes (nOCY) considered to respond to mechanical tissue loading and orchestrate the action of osteoblasts and osteoclasts accordingly.
In order to update the CA, rules are defined that are applied to each CA cell simultaneously and considering a certain neighbourhood. For each
In our prototype AIS CA, the update rule is the same for every CA cell. Our prototype employs the following update rule: The new SED values for each voxel computed with the micro-FE method is an input. In a first update step, the cell numbers based on a function that transforms SED values to an increase or decrease of OBL/OCL are modified according to the SED-bone remodelling relationship found earlier [7]. To avoid infinite increase/decrease of cells, they are saturated at a minimum and maximum level for both, OBL and OCL. In a second step, the Boolean network for each voxel is evaluated, which will again result in modifications to the OBL/OCL counts. Finally, the tissue density is updated based on the OBL/OCL counts. If the density values are higher than bone, they are distributed to the neighbouring voxels. The initial bone cell count and distribution are determined in a preceding iteration where more OBLs are placed in regions of high SED and more OCLs in regions of low SED. The CA is only updated a few layers away from the top and bottom where the boundary conditions of the micro-FE analysis are applied to exclude boundary artefacts.
2.3 Boolean network
The interaction of the local molecules with the local biological cells under the influence of mechanical loading in each CA cell is modelled with a Boolean network. Each molecule is either present in a CA cell or not. The number of CA cells in which a specific molecule is present, is governed by the measurement of the appropriate serum marker. In the present AIS network, RANKL, OPG, vitamin D, PTH, OCL, OBL and mechanical tissue loading (Mech) are integrated. The corresponding Boolean functions are as follows:
All molecules are either present or not. They are represented by a Boolean value. Mech is a thresholded Boolean value of ϵ. The cell numbers/activities of OBL/OCL are also thresholded. The molecule states are initialised randomly with a spatially uniform distribution and an average cover rate of 50%. Molecules that are never updated in the network are redistributed before every time iteration to avoid bias due to the specific configuration that was generated for the first iteration. OBL is then increased if PTH is true whereas OCL is increased if RANKL is true.
2.4 Computational implementation
The presented modelling approach is well suited for parallel implementation since each CA cell only depends on its nearest neighbourhood but is propagated independently with each time step. We therefore implemented the prototype for the execution on a graphics processing unit (GPU) using OpenCL. This allows to exploit the large amount of computing units available on a GPU compared to only a few cores of a CPU on a normal computer workstation. The analysis is performed with the dedicated micro-FE solver ParOSol [8] on the CPU. Boundary conditions are defined according to a bone loading estimation algorithm [9], providing physiological in vivo loading for this particular patient. They include compression (zz-direction) and shear strains (zx- and zy-direction). For the CA, biological cell and tissue density, molecular states as well as the mechanical tissue loading are stored for the full CA domain and thus a so called full-space approach is followed. Tissue density and loading are stored as floating point numbers. Since GPU memory is very limited, the biological cell count/activity per voxel is restricted to 8-bit characters, which still provides 256 quantification levels. For each molecule, only 1 bit is needed in the Boolean network, thus, for each voxel all molecular information can be encoded in a single byte.
3 Results
In the control simulation, bone density stayed constant with only a minor change of 0.03% between start and end point, representing normal healthy bone remodelling with 1.40% formation and 1.43% resorption. Reducing physical activity led to a decrease of 20.65% in bone density with 1.40% and 22.05% bone formation and resorption, respectively (Figure 1). In both cases, RANKL/OPG did not change during the simulated time.
Calculating tissue loading with micro-FE analysis required 494 s on a supercomputer (96 CPU cores, CSCS Cray XC40) while the CA computation including the Boolean network required 45 s on a workstation GPU (AMD Radeon HD 6750M 1024 MB, MacBook Pro 2011).

Differences in bone density between the first and last iteration for a control and a low physical activity simulation of an AIS patient. Bone resorption is depicted in red, formation in green, and no change in white transparent.
4 Discussion
We here propose an in silico prognosis approach to combine varying clinical measurements and thus clinical big data to explore complex diseases. The theoretical basis is outlined as well as a first prototype simulating AIS related bone loss due to inadequate physical activity is presented. We successfully demonstrate this effect by feeding clinical big data including medical images, serum markers, and physical activity levels into the in silico prognosis. Mobile monitoring data could potentially be included, too.
Our results are in agreement with bone’s capability to adapt to mechanical loading since bone density decreased with decreasing physical activity. The in silico method furthermore allows a more local analysis of bone loss, showing that resorption occurred predominantly in cortical bone and the centre of trabecular bone indicating alterations in spatial bone remodelling activity that might be linked to the local mechanical loading conditions. Bone formation, in contrast, occurred more evenly distributed throughout the trabecular bone.
The current implementation is very fast with only a few seconds execution time. However, micro-FE calculations were performed on a supercomputer and are currently coupled through a shared results file with the CA requiring additional file reading/writing. Computation time could thus be reduced by including the micro-FE solver in the CA. Although the Boolean networks are modelled for each image voxel, they do not add much to the total computation time and thus, they might be extended to include several quantification levels similar to how the biological cell counts are implemented.
In conclusion, the present in silico prognosis method allows to account for a variety of clinical measurements to study complex diseases using the concept of big data.
Acknowledgement
This work has been supported by the Holcim Stiftung for the Advancement of Scientific Research and the Swiss National Supercomputing Centre (CSCS).
Author’s Statement
Conflict of interest: Authors state no conflict of interest. Material and Methods: Informed consent: Informed consent has been obtained from all individuals included in this study. Ethical approval: The research related to human use complies with all the relevant national regulations, institutional policies and was performed in accordance with the tenets of the Helsinki Declaration, and has been approved by the authors’ institutional review board or equivalent committee.
References
[1] Cheng JC, Castelein RM, Chu WC, Danielsson AJ, Dobbs MB, Grivas TB, et al. Adolescent idiopathic scoliosis. Nat Rev Dis Primers. 2015;1:15068.10.1038/nrdp.2015.30Suche in Google Scholar PubMed
[2] Yu WS, Chan KY, Yu FWP, Ng BKW, Lee K-M, Qin L, et al. Bone structural and mechanical indices in adolescent idiopathic scoliosis evaluated by high-resolution peripheral quantitative computed tomography (HR-pQCT). Bone. 2014;61:109–15.10.1016/j.bone.2013.12.033Suche in Google Scholar PubMed
[3] Lee WT, Cheung CS, Tse YK, Guo X, Qin L, Ho SC, et al. Generalized low bone mass of girls with adolescent idiopathic scoliosis is related to inadequate calcium intake and weight bearing physical activity in peripubertal period. Osteoporos Int. 2005;16:1024–35.10.1007/s00198-004-1792-1Suche in Google Scholar PubMed
[4] Batista R, Martins DE, Hayashi LF, Lazaretti-Castro M, Puertas EB, Wajchenberg M. Association between vitamin D serum levels and adolescent idiopathic scoliosis. Scoliosis. 2014;9(Suppl 1): O45.10.1186/1748-7161-9-S1-O45Suche in Google Scholar
[5] Slemenda CW, Miller JZ, Hui SL, Reister TK, Johnston CC Jr. Role of physical activity in the development of skeletal mass in children. J Bone Miner Res. 1991;6:1227–33.10.1002/jbmr.5650061113Suche in Google Scholar PubMed
[6] Lam TP, Ng BKW, Cheung LWH, Lee KM, Qin L, Cheng JCY. Effect of whole body vibration (WBV) therapy on bone density and bone quality in osteopenic girls with adolescent idiopathic scoliosis: a randomized, controlled trial. Osteoporos Int. 2013;24:1623–36.10.1007/s00198-012-2144-1Suche in Google Scholar PubMed
[7] Christen P, Ito K, Ellouz R, Boutroy S, Sornay-Rendu E, Chapurlat RD, et al. Bone remodelling in humans is load-driven but not lazy. Nat Commun. 2014;5:4855.10.1038/ncomms5855Suche in Google Scholar PubMed
[8] Flaig C, Arbenz P. A scalable memory efficient multigrid solver for micro-finite element analyses based on CT images. Parallel Comput. 2011;37:846–54.10.1016/j.parco.2011.08.001Suche in Google Scholar
[9] Christen P, Schulte FA, Zwahlen A, van Rietbergen B, Boutroy S, Melton LJ, et al. Voxel size dependency, reproducibility and sensitivity of an in vivo bone loading estimation algorithm. J R Soc Interface. 2016;13.10.1098/rsif.2015.0991Suche in Google Scholar PubMed PubMed Central
©2016 Patrik Christen et al., licensee De Gruyter.
This work is licensed under the Creative Commons Attribution-NonCommercial-NoDerivatives 4.0 License.
Artikel in diesem Heft
- Synthesis and characterization of PIL/pNIPAAm hybrid hydrogels
- Novel blood protein based scaffolds for cardiovascular tissue engineering
- Cell adhesion and viability of human endothelial cells on electrospun polymer scaffolds
- Effects of heat treatment and welding process on superelastic behaviour and microstructure of micro electron beam welded NiTi
- Long-term stable modifications of silicone elastomer for improved hemocompatibility
- The effect of thermal treatment on the mechanical properties of PLLA tubular specimens
- Biocompatible wear-resistant thick ceramic coating
- Protection of active implant electronics with organosilicon open air plasma coating for plastic overmolding
- Examination of dielectric strength of thin Parylene C films under various conditions
- Open air plasma deposited antimicrobial SiOx/TiOx composite films for biomedical applications
- Systemic analysis about residual chloroform in PLLA films
- A macrophage model of osseointegration
- Towards in silico prognosis using big data
- Technical concept and evaluation of a novel shoulder simulator with adaptive muscle force generation and free motion
- Usability evaluation of a locomotor therapy device considering different strategies
- Hypoxia-on-a-chip
- Integration of a semi-automatic in-vitro RFA procedure into an experimental setup
- Fabrication of MEMS-based 3D-μECoG-MEAs
- High speed digital interfacing for a neural data acquisition system
- Bionic forceps for the handling of sensitive tissue
- Experimental studies on 3D printing of barium titanate ceramics for medical applications
- Patient specific root-analogue dental implants – additive manufacturing and finite element analysis
- 3D printing – a key technology for tailored biomedical cell culture lab ware
- 3D printing of hydrogels in a temperature controlled environment with high spatial resolution
- Biocompatibility of photopolymers for additive manufacturing
- Biochemical piezoresistive sensors based on pH- and glucose-sensitive hydrogels for medical applications
- Novel wireless measurement system of pressure dedicated to in vivo studies
- Portable auricular device for real-time swallow and chew detection
- Detection of miRNA using a surface plasmon resonance biosensor and antibody amplification
- Simulation and evaluation of stimulation scenarios for targeted vestibular nerve excitation
- Deep brain stimulation: increasing efficiency by alternative waveforms
- Prediction of immediately occurring microsleep events from brain electric signals
- Determining cardiac vagal threshold from short term heart rate complexity
- Classification of cardiac excitation patterns during atrial fibrillation
- An algorithm to automatically determine the cycle length coverage to identify rotational activity during atrial fibrillation – a simulation study
- Deriving respiration from high resolution 12-channel-ECG during cycling exercise
- Reducing of gradient induced artifacts on the ECG signal during MRI examinations using Wilcoxon filter
- Automatic detection and mapping of double potentials in intracardiac electrograms
- Modeling the pelvic region for non-invasive pelvic intraoperative neuromonitoring
- Postprocessing algorithm for automated analysis of pelvic intraoperative neuromonitoring signals
- Best practice: surgeon driven application in pelvic operations
- Vasomotor assessment by camera-based photoplethysmography
- Classification of morphologic changes in photoplethysmographic waveforms
- Novel computation of pulse transit time from multi-channel PPG signals by wavelet transform
- Efficient design of FIR filter based low-pass differentiators for biomedical signal processing
- Nonlinear causal influences assessed by mutual compression entropy
- Comparative study of methods for solving the correspondence problem in EMD applications
- fNIRS for future use in auditory diagnostics
- Semi-automated detection of fractional shortening in zebrafish embryo heart videos
- Blood pressure measurement on the cheek
- Derivation of the respiratory rate from directly and indirectly measured respiratory signals using autocorrelation
- Left cardiac atrioventricular delay and inter-ventricular delay in cardiac resynchronization therapy responder and non-responder
- An automatic systolic peak detector of blood pressure waveforms using 4th order cumulants
- Real-time QRS detection using integrated variance for ECG gated cardiac MRI
- Preprocessing of unipolar signals acquired by a novel intracardiac mapping system
- In-vitro experiments to characterize ventricular electromechanics
- Continuous non-invasive monitoring of blood pressure in the operating room: a cuffless optical technology at the fingertip
- Application of microwave sensor technology in cardiovascular disease for plaque detection
- Artificial blood circulatory and special Ultrasound Doppler probes for detecting and sizing gaseous embolism
- Detection of microsleep events in a car driving simulation study using electrocardiographic features
- A method to determine the kink resistance of stents and stent delivery systems according to international standards
- Comparison of stented bifurcation and straight vessel 3D-simulation with a prior simulated velocity profile inlet
- Transient Euler-Lagrange/DEM simulation of stent thrombosis
- Automated control of the laser welding process of heart valve scaffolds
- Automation of a test bench for accessing the bendability of electrospun vascular grafts
- Influence of storage conditions on the release of growth factors in platelet-rich blood derivatives
- Cryopreservation of cells using defined serum-free cryoprotective agents
- New bioreactor vessel for tissue engineering of human nasal septal chondrocytes
- Determination of the membrane hydraulic permeability of MSCs
- Climate retainment in carbon dioxide incubators
- Multiple factors influencing OR ventilation system effectiveness
- Evaluation of an app-based stress protocol
- Medication process in Styrian hospitals
- Control tower to surgical theater
- Development of a skull phantom for the assessment of implant X-ray visibility
- Surgical navigation with QR codes
- Investigation of the pressure gradient of embolic protection devices
- Computer assistance in femoral derotation osteotomy: a bottom-up approach
- Automatic depth scanning system for 3D infrared thermography
- A service for monitoring the quality of intraoperative cone beam CT images
- Resectoscope with an easy to use twist mechanism for improved handling
- In vitro simulation of distribution processes following intramuscular injection
- Adjusting inkjet printhead parameters to deposit drugs into micro-sized reservoirs
- A flexible standalone system with integrated sensor feedback for multi-pad electrode FES of the hand
- Smart control for functional electrical stimulation with optimal pulse intensity
- Tactile display on the remaining hand for unilateral hand amputees
- Effects of sustained electrical stimulation on spasticity assessed by the pendulum test
- An improved tracking framework for ultrasound probe localization in image-guided radiosurgery
- Improvement of a subviral particle tracker by the use of a LAP-Kalman-algorithm
- Learning discriminative classification models for grading anal intraepithelial neoplasia
- Regularization of EIT reconstruction based on multi-scales wavelet transforms
- Assessing MRI susceptibility artefact through an indicator of image distortion
- EyeGuidance – a computer controlled system to guide eye movements
- A framework for feedback-based segmentation of 3D image stacks
- Doppler optical coherence tomography as a promising tool for detecting fluid in the human middle ear
- 3D Local in vivo Environment (LivE) imaging for single cell protein analysis of bone tissue
- Inside-Out access strategy using new trans-vascular catheter approach
- US/MRI fusion with new optical tracking and marker approach for interventional procedures inside the MRI suite
- Impact of different registration methods in MEG source analysis
- 3D segmentation of thyroid ultrasound images using active contours
- Designing a compact MRI motion phantom
- Cerebral cortex classification by conditional random fields applied to intraoperative thermal imaging
- Classification of indirect immunofluorescence images using thresholded local binary count features
- Analysis of muscle fatigue conditions using time-frequency images and GLCM features
- Numerical evaluation of image parameters of ETR-1
- Fabrication of a compliant phantom of the human aortic arch for use in Particle Image Velocimetry (PIV) experimentation
- Effect of the number of electrodes on the reconstructed lung shape in electrical impedance tomography
- Hardware dependencies of GPU-accelerated beamformer performances for microwave breast cancer detection
- Computer assisted assessment of progressing osteoradionecrosis of the jaw for clinical diagnosis and treatment
- Evaluation of reconstruction parameters of electrical impedance tomography on aorta detection during saline bolus injection
- Evaluation of open-source software for the lung segmentation
- Automatic determination of lung features of CF patients in CT scans
- Image analysis of self-organized multicellular patterns
- Effect of key parameters on synthesis of superparamagnetic nanoparticles (SPIONs)
- Radiopacity assessment of neurovascular implants
- Development of a desiccant based dielectric for monitoring humidity conditions in miniaturized hermetic implantable packages
- Development of an artifact-free aneurysm clip
- Enhancing the regeneration of bone defects by alkalizing the peri-implant zone – an in vitro approach
- Rapid prototyping of replica knee implants for in vitro testing
- Protecting ultra- and hyperhydrophilic implant surfaces in dry state from loss of wettability
- Advanced wettability analysis of implant surfaces
- Patient-specific hip prostheses designed by surgeons
- Plasma treatment on novel carbon fiber reinforced PEEK cages to enhance bioactivity
- Wear of a total intervertebral disc prosthesis
- Digital health and digital biomarkers – enabling value chains on health data
- Usability in the lifecycle of medical software development
- Influence of different test gases in a non-destructive 100% quality control system for medical devices
- Device development guided by user satisfaction survey on auricular vagus nerve stimulation
- Empirical assessment of the time course of innovation in biomedical engineering: first results of a comparative approach
- Effect of left atrial hypertrophy on P-wave morphology in a computational model
- Simulation of intracardiac electrograms around acute ablation lesions
- Parametrization of activation based cardiac electrophysiology models using bidomain model simulations
- Assessment of nasal resistance using computational fluid dynamics
- Resistance in a non-linear autoregressive model of pulmonary mechanics
- Inspiratory and expiratory elastance in a non-linear autoregressive model of pulmonary mechanics
- Determination of regional lung function in cystic fibrosis using electrical impedance tomography
- Development of parietal bone surrogates for parietal graft lift training
- Numerical simulation of mechanically stimulated bone remodelling
- Conversion of engineering stresses to Cauchy stresses in tensile and compression tests of thermoplastic polymers
- Numerical examinations of simplified spondylodesis models concerning energy absorption in magnetic resonance imaging
- Principle study on the signal connection at transabdominal fetal pulse oximetry
- Influence of Siluron® insertion on model drug distribution in the simulated vitreous body
- Evaluating different approaches to identify a three parameter gas exchange model
- Effects of fibrosis on the extracellular potential based on 3D reconstructions from histological sections of heart tissue
- From imaging to hemodynamics – how reconstruction kernels influence the blood flow predictions in intracranial aneurysms
- Flow optimised design of a novel point-of-care diagnostic device for the detection of disease specific biomarkers
- Improved FPGA controlled artificial vascular system for plethysmographic measurements
- Minimally spaced electrode positions for multi-functional chest sensors: ECG and respiratory signal estimation
- Automated detection of alveolar arches for nasoalveolar molding in cleft lip and palate treatment
- Control scheme selection in human-machine- interfaces by analysis of activity signals
- Event-based sampling for reducing communication load in realtime human motion analysis by wireless inertial sensor networks
- Automatic pairing of inertial sensors to lower limb segments – a plug-and-play approach
- Contactless respiratory monitoring system for magnetic resonance imaging applications using a laser range sensor
- Interactive monitoring system for visual respiratory biofeedback
- Development of a low-cost senor based aid for visually impaired people
- Patient assistive system for the shoulder joint
- A passive beating heart setup for interventional cardiology training
Artikel in diesem Heft
- Synthesis and characterization of PIL/pNIPAAm hybrid hydrogels
- Novel blood protein based scaffolds for cardiovascular tissue engineering
- Cell adhesion and viability of human endothelial cells on electrospun polymer scaffolds
- Effects of heat treatment and welding process on superelastic behaviour and microstructure of micro electron beam welded NiTi
- Long-term stable modifications of silicone elastomer for improved hemocompatibility
- The effect of thermal treatment on the mechanical properties of PLLA tubular specimens
- Biocompatible wear-resistant thick ceramic coating
- Protection of active implant electronics with organosilicon open air plasma coating for plastic overmolding
- Examination of dielectric strength of thin Parylene C films under various conditions
- Open air plasma deposited antimicrobial SiOx/TiOx composite films for biomedical applications
- Systemic analysis about residual chloroform in PLLA films
- A macrophage model of osseointegration
- Towards in silico prognosis using big data
- Technical concept and evaluation of a novel shoulder simulator with adaptive muscle force generation and free motion
- Usability evaluation of a locomotor therapy device considering different strategies
- Hypoxia-on-a-chip
- Integration of a semi-automatic in-vitro RFA procedure into an experimental setup
- Fabrication of MEMS-based 3D-μECoG-MEAs
- High speed digital interfacing for a neural data acquisition system
- Bionic forceps for the handling of sensitive tissue
- Experimental studies on 3D printing of barium titanate ceramics for medical applications
- Patient specific root-analogue dental implants – additive manufacturing and finite element analysis
- 3D printing – a key technology for tailored biomedical cell culture lab ware
- 3D printing of hydrogels in a temperature controlled environment with high spatial resolution
- Biocompatibility of photopolymers for additive manufacturing
- Biochemical piezoresistive sensors based on pH- and glucose-sensitive hydrogels for medical applications
- Novel wireless measurement system of pressure dedicated to in vivo studies
- Portable auricular device for real-time swallow and chew detection
- Detection of miRNA using a surface plasmon resonance biosensor and antibody amplification
- Simulation and evaluation of stimulation scenarios for targeted vestibular nerve excitation
- Deep brain stimulation: increasing efficiency by alternative waveforms
- Prediction of immediately occurring microsleep events from brain electric signals
- Determining cardiac vagal threshold from short term heart rate complexity
- Classification of cardiac excitation patterns during atrial fibrillation
- An algorithm to automatically determine the cycle length coverage to identify rotational activity during atrial fibrillation – a simulation study
- Deriving respiration from high resolution 12-channel-ECG during cycling exercise
- Reducing of gradient induced artifacts on the ECG signal during MRI examinations using Wilcoxon filter
- Automatic detection and mapping of double potentials in intracardiac electrograms
- Modeling the pelvic region for non-invasive pelvic intraoperative neuromonitoring
- Postprocessing algorithm for automated analysis of pelvic intraoperative neuromonitoring signals
- Best practice: surgeon driven application in pelvic operations
- Vasomotor assessment by camera-based photoplethysmography
- Classification of morphologic changes in photoplethysmographic waveforms
- Novel computation of pulse transit time from multi-channel PPG signals by wavelet transform
- Efficient design of FIR filter based low-pass differentiators for biomedical signal processing
- Nonlinear causal influences assessed by mutual compression entropy
- Comparative study of methods for solving the correspondence problem in EMD applications
- fNIRS for future use in auditory diagnostics
- Semi-automated detection of fractional shortening in zebrafish embryo heart videos
- Blood pressure measurement on the cheek
- Derivation of the respiratory rate from directly and indirectly measured respiratory signals using autocorrelation
- Left cardiac atrioventricular delay and inter-ventricular delay in cardiac resynchronization therapy responder and non-responder
- An automatic systolic peak detector of blood pressure waveforms using 4th order cumulants
- Real-time QRS detection using integrated variance for ECG gated cardiac MRI
- Preprocessing of unipolar signals acquired by a novel intracardiac mapping system
- In-vitro experiments to characterize ventricular electromechanics
- Continuous non-invasive monitoring of blood pressure in the operating room: a cuffless optical technology at the fingertip
- Application of microwave sensor technology in cardiovascular disease for plaque detection
- Artificial blood circulatory and special Ultrasound Doppler probes for detecting and sizing gaseous embolism
- Detection of microsleep events in a car driving simulation study using electrocardiographic features
- A method to determine the kink resistance of stents and stent delivery systems according to international standards
- Comparison of stented bifurcation and straight vessel 3D-simulation with a prior simulated velocity profile inlet
- Transient Euler-Lagrange/DEM simulation of stent thrombosis
- Automated control of the laser welding process of heart valve scaffolds
- Automation of a test bench for accessing the bendability of electrospun vascular grafts
- Influence of storage conditions on the release of growth factors in platelet-rich blood derivatives
- Cryopreservation of cells using defined serum-free cryoprotective agents
- New bioreactor vessel for tissue engineering of human nasal septal chondrocytes
- Determination of the membrane hydraulic permeability of MSCs
- Climate retainment in carbon dioxide incubators
- Multiple factors influencing OR ventilation system effectiveness
- Evaluation of an app-based stress protocol
- Medication process in Styrian hospitals
- Control tower to surgical theater
- Development of a skull phantom for the assessment of implant X-ray visibility
- Surgical navigation with QR codes
- Investigation of the pressure gradient of embolic protection devices
- Computer assistance in femoral derotation osteotomy: a bottom-up approach
- Automatic depth scanning system for 3D infrared thermography
- A service for monitoring the quality of intraoperative cone beam CT images
- Resectoscope with an easy to use twist mechanism for improved handling
- In vitro simulation of distribution processes following intramuscular injection
- Adjusting inkjet printhead parameters to deposit drugs into micro-sized reservoirs
- A flexible standalone system with integrated sensor feedback for multi-pad electrode FES of the hand
- Smart control for functional electrical stimulation with optimal pulse intensity
- Tactile display on the remaining hand for unilateral hand amputees
- Effects of sustained electrical stimulation on spasticity assessed by the pendulum test
- An improved tracking framework for ultrasound probe localization in image-guided radiosurgery
- Improvement of a subviral particle tracker by the use of a LAP-Kalman-algorithm
- Learning discriminative classification models for grading anal intraepithelial neoplasia
- Regularization of EIT reconstruction based on multi-scales wavelet transforms
- Assessing MRI susceptibility artefact through an indicator of image distortion
- EyeGuidance – a computer controlled system to guide eye movements
- A framework for feedback-based segmentation of 3D image stacks
- Doppler optical coherence tomography as a promising tool for detecting fluid in the human middle ear
- 3D Local in vivo Environment (LivE) imaging for single cell protein analysis of bone tissue
- Inside-Out access strategy using new trans-vascular catheter approach
- US/MRI fusion with new optical tracking and marker approach for interventional procedures inside the MRI suite
- Impact of different registration methods in MEG source analysis
- 3D segmentation of thyroid ultrasound images using active contours
- Designing a compact MRI motion phantom
- Cerebral cortex classification by conditional random fields applied to intraoperative thermal imaging
- Classification of indirect immunofluorescence images using thresholded local binary count features
- Analysis of muscle fatigue conditions using time-frequency images and GLCM features
- Numerical evaluation of image parameters of ETR-1
- Fabrication of a compliant phantom of the human aortic arch for use in Particle Image Velocimetry (PIV) experimentation
- Effect of the number of electrodes on the reconstructed lung shape in electrical impedance tomography
- Hardware dependencies of GPU-accelerated beamformer performances for microwave breast cancer detection
- Computer assisted assessment of progressing osteoradionecrosis of the jaw for clinical diagnosis and treatment
- Evaluation of reconstruction parameters of electrical impedance tomography on aorta detection during saline bolus injection
- Evaluation of open-source software for the lung segmentation
- Automatic determination of lung features of CF patients in CT scans
- Image analysis of self-organized multicellular patterns
- Effect of key parameters on synthesis of superparamagnetic nanoparticles (SPIONs)
- Radiopacity assessment of neurovascular implants
- Development of a desiccant based dielectric for monitoring humidity conditions in miniaturized hermetic implantable packages
- Development of an artifact-free aneurysm clip
- Enhancing the regeneration of bone defects by alkalizing the peri-implant zone – an in vitro approach
- Rapid prototyping of replica knee implants for in vitro testing
- Protecting ultra- and hyperhydrophilic implant surfaces in dry state from loss of wettability
- Advanced wettability analysis of implant surfaces
- Patient-specific hip prostheses designed by surgeons
- Plasma treatment on novel carbon fiber reinforced PEEK cages to enhance bioactivity
- Wear of a total intervertebral disc prosthesis
- Digital health and digital biomarkers – enabling value chains on health data
- Usability in the lifecycle of medical software development
- Influence of different test gases in a non-destructive 100% quality control system for medical devices
- Device development guided by user satisfaction survey on auricular vagus nerve stimulation
- Empirical assessment of the time course of innovation in biomedical engineering: first results of a comparative approach
- Effect of left atrial hypertrophy on P-wave morphology in a computational model
- Simulation of intracardiac electrograms around acute ablation lesions
- Parametrization of activation based cardiac electrophysiology models using bidomain model simulations
- Assessment of nasal resistance using computational fluid dynamics
- Resistance in a non-linear autoregressive model of pulmonary mechanics
- Inspiratory and expiratory elastance in a non-linear autoregressive model of pulmonary mechanics
- Determination of regional lung function in cystic fibrosis using electrical impedance tomography
- Development of parietal bone surrogates for parietal graft lift training
- Numerical simulation of mechanically stimulated bone remodelling
- Conversion of engineering stresses to Cauchy stresses in tensile and compression tests of thermoplastic polymers
- Numerical examinations of simplified spondylodesis models concerning energy absorption in magnetic resonance imaging
- Principle study on the signal connection at transabdominal fetal pulse oximetry
- Influence of Siluron® insertion on model drug distribution in the simulated vitreous body
- Evaluating different approaches to identify a three parameter gas exchange model
- Effects of fibrosis on the extracellular potential based on 3D reconstructions from histological sections of heart tissue
- From imaging to hemodynamics – how reconstruction kernels influence the blood flow predictions in intracranial aneurysms
- Flow optimised design of a novel point-of-care diagnostic device for the detection of disease specific biomarkers
- Improved FPGA controlled artificial vascular system for plethysmographic measurements
- Minimally spaced electrode positions for multi-functional chest sensors: ECG and respiratory signal estimation
- Automated detection of alveolar arches for nasoalveolar molding in cleft lip and palate treatment
- Control scheme selection in human-machine- interfaces by analysis of activity signals
- Event-based sampling for reducing communication load in realtime human motion analysis by wireless inertial sensor networks
- Automatic pairing of inertial sensors to lower limb segments – a plug-and-play approach
- Contactless respiratory monitoring system for magnetic resonance imaging applications using a laser range sensor
- Interactive monitoring system for visual respiratory biofeedback
- Development of a low-cost senor based aid for visually impaired people
- Patient assistive system for the shoulder joint
- A passive beating heart setup for interventional cardiology training