Fact-checked by Grok 2 weeks ago

Model order reduction

Model order reduction (MOR) is a mathematical and computational technique that approximates complex, high-dimensional dynamical systems—often derived from partial differential equations (PDEs)—with simpler, lower-dimensional models while preserving essential dynamic properties, such as , response characteristics, and accuracy for specific inputs or parameters. This process involves projecting the system's state space onto a reduced , typically of r much smaller than the original n, to create a reduced-order model (ROM) that mimics the full-order model (FOM) with minimal error. The primary purpose of MOR is to mitigate the computational burdens associated with simulating, analyzing, optimizing, or controlling large-scale systems, where n can reach millions due to spatial methods like finite element or finite volume schemes. By reducing model size, MOR lowers storage requirements and accelerates computations—from O(n³) operations in direct simulations to O(r³) in the reduced space—enabling applications, , and parametric studies that would otherwise be infeasible. It is particularly vital in scenarios involving repetitive queries, such as or inverse problems, where offline computation of the reduced basis offsets online efficiency gains. Key methods in MOR encompass both projection-based and data-driven approaches, tailored to linear and nonlinear systems. For linear systems, techniques like balanced truncation identify and retain high-energy modes by balancing controllability and observability Gramians, ensuring error bounds in norms like the H₂ or H∞. Proper orthogonal decomposition (POD), also known as snapshot-based reduction, constructs an optimal subspace from simulation data via singular value decomposition (SVD), capturing dominant variances. In nonlinear contexts, extensions such as proper generalized decomposition (PGD) separate multidimensional variables (e.g., space, time, parameters) to generate parametric ROMs, while Koopman operator theory linearizes nonlinear dynamics in a lifted space for modal analysis. Advanced variants, like the iterative rational Krylov algorithm (IRKA), optimize reductions for H₂-norm matching in control-oriented applications. MOR finds broad applications across engineering and scientific domains, addressing challenges in high-fidelity modeling. In fluid dynamics and computational mechanics, it accelerates simulations of turbulent flows, fluid-structure interactions, and structural vibrations. Control theory employs MOR for designing reduced-order controllers in aerospace and automotive systems, ensuring stability in feedback loops. In microelectromechanical systems (MEMS) and circuit design, it simplifies transient analyses of large-scale integrated circuits. Emerging uses include biomedical engineering for real-time tissue simulations, quantum chemistry for uncertainty propagation in molecular dynamics, and finance for efficient option pricing under parametric variations. Despite its benefits, MOR requires careful validation to handle nonlinearities, parameter variations, and certification for safety-critical systems.

Introduction

Definition and Purpose

Model order reduction (MOR) is a computational used to approximate high-dimensional dynamical systems—typically resulting from spatial discretizations such as finite element or finite volume methods—with lower-dimensional equivalents that capture the essential behavior of the original model while significantly reducing computational demands. These high-fidelity models often involve thousands or millions of due to fine discretizations required for accuracy in simulating complex physical phenomena. The primary purpose of is to enable efficient applications such as simulations, studies, optimization tasks, and design, where full-scale models are prohibitively expensive in terms of time and resources. By decreasing the number of from thousands or millions to tens or hundreds, facilitates faster computations and lower memory usage without substantial loss in predictive capability. For instance, in state-space representations, the original system dimension n is reduced to a much smaller r \ll n, preserving the input-output essential for practical use. Key benefits of MOR include accelerated solution times and the ability to perform repeated evaluations in and workflows. Effective reduction requires preserving critical properties of the original system, including to ensure long-term simulation reliability, passivity for energy-dissipative systems, and accurate matching to maintain dynamic characteristics across relevant spectra. These preservation aspects are often addressed through projection-based approaches that align the reduced model with the high-fidelity one.

Historical Development

The origins of model order reduction (MOR) trace back to the mid-20th century, with early techniques emerging in and . In the and , modal truncation methods were developed to simplify high-dimensional models by retaining only the dominant modes of , a practice rooted in the analysis of linear structural systems. A seminal contribution was the Guyan reduction method, introduced in , which performs static condensation to eliminate internal while preserving boundary dynamics, particularly useful for finite element models in . These approaches laid the groundwork for reducing in simulating mechanical systems without significant loss of accuracy in low-frequency responses. The 1970s and 1980s marked significant advancements in reduction, driven by . Brian C. Moore introduced balanced realizations in 1981, transforming the system into a form where and Gramians are equal and diagonal, enabling the truncation of states with small Hankel singular values to achieve near-optimal error bounds. Building on this, Y. Liu and B. D. O. Anderson developed balanced truncation in 1989, providing a computationally efficient that guarantees and passivity preservation for reduced models, widely adopted in control applications. These methods emphasized error minimization in the H2 or Hankel norm, influencing fields like and . The saw a surge in data-driven and projection-based techniques, particularly for large-scale systems. (POD), originally proposed by John L. Lumley in 1967 for identifying coherent structures in turbulent flows, gained prominence in the for MOR in through snapshot-based empirical bases derived from . Concurrently, methods, leveraging the Arnoldi algorithm for orthogonal projections, emerged for moment-matching in circuit simulation and discretizations, enabling efficient handling of high-order systems in VLSI design. From the 2000s onward, MOR extended to nonlinear systems and integrated with emerging paradigms. Nonlinear extensions, such as the empirical interpolation method introduced in 2010 (building on 2009 concepts), addressed hyper-reduction in POD-Galerkin projections for parametric simulations in (CFD). Nonintrusive data-driven approaches proliferated, using operator inference for black-box reductions. Post-2015, integration with , including neural networks for manifold learning and autoencoders for nonlinear embeddings, enhanced adaptability in real-time control and . As of 2025, further advances incorporate physics-informed techniques, such as neural networks for automatic model reduction in and scientific for complex problems. Key contributors like Athanasios C. Antoulas, Peter Benner, and Wil H. A. Schilders advanced theoretical frameworks and algorithms, with applications spanning VLSI circuit simulation and CFD.

Fundamentals

Mathematical Formulation of Models

High-fidelity models in model order reduction are typically represented in state-space form to capture the dynamics of physical systems. For linear time-invariant (LTI) systems, the continuous-time formulation is given by \dot{x}(t) = A x(t) + B u(t), \quad y(t) = C x(t) + D u(t), where x \in \mathbb{R}^n is the , u \in \mathbb{R}^m is the input, y \in \mathbb{R}^p is the output, and A \in \mathbb{R}^{n \times n}, B \in \mathbb{R}^{n \times m}, C \in \mathbb{R}^{p \times n}, D \in \mathbb{R}^{p \times m} are constant matrices. This representation originates from and serves as the foundation for reduction techniques that preserve key system properties, such as and response characteristics. Extensions to linear time-varying (LTV) systems incorporate time-dependent coefficients, yielding \dot{x}(t) = A(t) x(t) + B(t) u(t), \quad y(t) = C(t) x(t) + D(t) u(t), which arise in applications like or systems with varying operating conditions. For nonlinear dynamical systems, the state-space form generalizes to \dot{x}(t) = f(x(t), u(t)), \quad y(t) = g(x(t), u(t)), where f: \mathbb{R}^n \times \mathbb{R}^m \to \mathbb{R}^n and g: \mathbb{R}^n \times \mathbb{R}^m \to \mathbb{R}^p are nonlinear functions, capturing phenomena like bifurcations or chaotic behavior in and scientific simulations. In discrete-time settings, equivalent formulations are used for sampled-data systems or digital simulations. The LTI discrete-time model is x_{k+1} = A x_k + B u_k, \quad y_k = C x_k + D u_k, with k denoting the time step, allowing reduction methods to maintain stability margins. Similar extensions apply to LTV and nonlinear cases, often derived from of continuous models. High dimensionality in these models (n up to $10^6 or more) typically stems from spatial of partial differential equations (PDEs) using methods like finite elements or finite differences, resulting in large sparse matrices that represent semi-discretized systems. For instance, simulating or yields ODEs of order proportional to the grid resolution, motivating reduction to enable computations. Parametric models introduce dependence on parameters \mu \in \mathcal{P}, often in affine form to facilitate efficient reduction, such as A(\mu) \approx \sum_{i=1}^q \theta_i(\mu) A_i for the system matrix, where \theta_i are scalar functions and A_i are parameter-independent snapshots; this structure is central to reduced basis methods for PDEs. Such decompositions enable offline-online , with the affine form ensuring low-cost online evaluations after precomputing basis functions. Descriptor systems, common in multiphysics applications like electrical circuits, extend the standard form to E \dot{x}(t) = A x(t) + B u(t), \quad y(t) = C x(t) + D u(t), where E \in \mathbb{R}^{n \times n} is singular, introducing algebraic constraints alongside equations; reduction preserves the descriptor and .

Reduction Objectives and Criteria

The primary objectives of model order reduction () are to approximate the input-output behavior of high-dimensional dynamical systems while significantly lowering computational demands, such that the reduced-order H_r(s) closely matches the original H(s) across relevant frequencies or time scales. This approximation preserves essential structural properties of the system, including , passivity, and , ensuring that the reduced model maintains physical realism and suitability for downstream tasks like and . For instance, preservation guarantees that asymptotic behavior remains consistent, while passivity ensures energy dissipation characteristics are retained in physical systems. Quality criteria for MOR focus on quantifiable measures of fidelity, such as relative errors in the \mathcal{H}_2 and \mathcal{H}_\infty norms, where the goal is to achieve \|H - H_r\| < \epsilon for a specified tolerance \epsilon, often evaluated over frequency ranges of interest. Moment matching serves as a key criterion for capturing the frequency response, by aligning the first k Taylor series coefficients (moments) of H(s) and H_r(s) at selected expansion points, which promotes local accuracy in the system's dynamics. These metrics prioritize global or local error minimization without compromising the reduced model's utility. A fundamental trade-off in MOR lies between the degree of dimensionality reduction—which can yield orders-of-magnitude savings in storage and simulation time—and the achievable accuracy, as aggressive reduction may amplify discrepancies in transient or steady-state responses. Additionally, the computational overhead of the reduction process itself must be balanced against the benefits, particularly for large-scale systems where projection or optimization steps can be resource-intensive. Domain-specific goals refine these objectives: in control theory, MOR aims to retain controllability and observability to ensure the reduced model supports effective feedback design and state estimation. In electrical circuits, preservation of impedance characteristics is critical to maintain network compatibility and passivity for stable interconnection. For parametric systems varying with parameters \mu, multi-objective criteria extend accuracy requirements across the parameter space, seeking reduced models that uniformly approximate responses for all \mu in a defined domain, often via certified error bounds that account for parametric variability.

Techniques

Linear Techniques

Linear techniques for model order reduction primarily focus on projection-based methods for linear dynamical systems of the form \dot{x} = A x + B u, y = C x + D u, where x \in \mathbb{R}^n is the state vector, u \in \mathbb{R}^m the input, y \in \mathbb{R}^p the output, and n \gg r with r the desired reduced order. These methods seek a reduced-order model \dot{\hat{x}} = \tilde{A} \hat{x} + \tilde{B} u, \hat{y} = \tilde{C} \hat{x} + \tilde{D} u with \hat{x} \in \mathbb{R}^r, obtained via a Petrov-Galerkin projection using transformation matrices V \in \mathbb{R}^{n \times r} (trial basis) and W \in \mathbb{R}^{n \times r} (test basis), yielding reduced matrices \tilde{A} = W^T A V, \tilde{B} = W^T B, \tilde{C} = C V, and \tilde{D} = D. Often, the bases satisfy biorthogonality W^T V = I_r, and for descriptor systems E \dot{x} = A x + B u, the projection enforces W^T E V = I_r to preserve structure. The choice of V and W is critical; they can be derived via singular value decomposition (SVD) for energy minimization or orthogonalization processes like Gram-Schmidt to ensure numerical stability. Balanced truncation is a prominent H2-optimal projection method that balances the system's controllability and observability properties to minimize reduction error. It involves computing the controllability Gramian W_c and observability Gramian W_o, solutions to Lyapunov equations A W_c + W_c A^T + B B^T = 0 and A^T W_o + W_o A + C^T C = 0, then performing a similarity transformation to a balanced realization where W_c = W_o = \Sigma = \operatorname{diag}(\sigma_1, \dots, \sigma_n) with Hankel singular values \sigma_i. Truncation discards states corresponding to small \sigma_i > \sigma_{r+1}, yielding a reduced model with H2 error bounded by $2 \sum_{i=r+1}^n \sigma_i \leq 2(n-r) \sigma_{r+1}. This method preserves and provides a priori error estimates, making it suitable for systems where Gramians are computable, though large-scale variants use iterative solvers. The approach was introduced for ensuring near-optimality in H2 norm for single-input single-output systems. Moment matching techniques, often implemented via projections, aim to match the first $2r moments (or Markov parameters) of the full and reduced functions at selected points, ensuring rational and preserving low-frequency or behavior. For single-input systems, the block Arnoldi algorithm generates an orthonormal basis V for the \mathcal{K}_r(A, B) = \operatorname{span}\{B, AB, \dots, A^{r-1}B\}, while Lanczos is used for symmetric cases; the dual subspace for outputs yields W. This results in \tilde{A}^{-1} \tilde{B} = V^T A^{-1} B matching moments up to order r-1, with extensions to multi-point matching via rational Krylov methods for broadband frequency response preservation. These methods are computationally efficient for sparse systems, as subspace iteration avoids full matrix inversions, and they excel in preserving passivity for circuit applications. Seminal developments integrated Krylov projections for efficient model reduction in linear systems. Proper orthogonal decomposition (POD), also known as Karhunen-Loève expansion, constructs empirical reduced bases from simulation data (snapshots) to capture dominant energy modes in linear systems. Snapshots \{x(t_i)\}_{i=1}^s from trajectories are collected into a X \in \mathbb{R}^{n \times s}, and X = U \Sigma U^T provides the basis V as the leading r left singular vectors, minimizing the mean-square projection error \|X - V V^T X\|_F. For linear systems, this yields a reduced model via Petrov-Galerkin with W = V, emphasizing energy-based optimality over dynamical properties. is particularly effective for data-driven reduction when analytical models are unavailable, though it requires offline simulations; often combines it with error estimators. The method originated in for extracting coherent structures from empirical data. Reduced basis (RB) methods extend projection techniques to parametric linear problems, such as A(\mu) x(\mu) = f(\mu) with parameter \mu \in \mathcal{P}, using a greedy algorithm to select a small set of snapshot parameters that maximize error indicators, forming an affine-decomposed basis V = [v_1, \dots, v_r]. The reduced operator is \tilde{A}(\mu) = V^T A(\mu) V, assuming an affine expansion A(\mu) = \sum_{q=1}^Q \theta_q(\mu) A_q for efficient online evaluation. Greedy sampling ensures exponential convergence in Kolmogorov n-width for analytic parameter dependence, with a posteriori error bounds guiding basis enrichment. RB is ideal for many-query parametric studies in PDEs discretized by finite elements, achieving reductions from millions to tens of degrees of freedom while maintaining certification. Foundational work established the greedy framework for parametrized PDEs. Other linear techniques include modal truncation, which diagonalizes the system via eigendecomposition A = T \Lambda T^{-1} and retains dominant eigenvalues in \Lambda_r, reducing via projection onto corresponding eigenvectors for stable, lightly damped modes while discarding fast transients. This is simple for modal analysis but ignores input-output coupling. Singular perturbation approximation treats small parameters \epsilon in \epsilon \dot{x}_2 = A_{22} x_2 + \dots, setting \dot{x}_2 \approx 0 for quasi-steady reduction, preserving slow dynamics with error O(\epsilon). These methods are computationally lightweight for structured systems like mechanical vibrations. Modal approaches trace to early control theory, while singular perturbation provides asymptotic guarantees for multi-scale systems.

Nonlinear Techniques

Nonlinear model order reduction () addresses the challenges inherent in high-fidelity simulations of systems governed by nonlinear , where traditional linear techniques fail due to the absence of superposition principles. These methods typically rely on data-driven approximations, empirical projections, or structural simplifications to construct low-dimensional models that preserve essential nonlinear behaviors while drastically reducing computational cost. Key approaches include manifold-based techniques for efficient evaluation of nonlinear terms, trajectory-based linearizations, nonintrusive data-driven decompositions, integrations with for latent space representations, and physics-based simplifications tailored to nonlinear partial equations (PDEs). Manifold-based approaches, such as the Discrete Empirical Interpolation Method (DEIM), enable efficient computation of nonlinear terms in reduced-order models (ROMs) by selecting a subset of points from to approximate high-dimensional nonlinear functions. DEIM, introduced by Chaturantabut and Sorensen in 2010, works in tandem with (POD) to project the system onto a low-dimensional manifold, where the nonlinear evaluations are approximated via , achieving independent of the full model dimension. An extension, the qDEIM (or Q-DEIM), proposed by Drmac and Gugercin in 2016, improves selection of interpolation indices using a QR-based , providing tighter a priori error bounds and enhanced stability for nonlinear ROMs, particularly in applications like simulations. The Trajectory Piecewise Linear (TPWL) method approximates nonlinear dynamics by linearizing the system along multiple simulation trajectories and blending the resulting local linear models. Developed by Rewienski and White in 2003, TPWL generates reduced-order linear approximations at key operating points derived from full-model trajectories, then weights them based on proximity to the current state, effectively capturing nonlinear effects without explicit projection of the full nonlinearity. This approach has been widely adopted for circuit simulation and , offering speedups of orders of magnitude while maintaining accuracy for moderately nonlinear responses. Nonintrusive methods, which avoid modifying the underlying solver, leverage data snapshots to approximate nonlinear dynamics through decompositions like (DMD). DMD, as applied to nonlinear MOR by Peherstorfer et al. in 2016, extracts spatio-temporal modes from time-series data to form a linear-like of the nonlinear evolution operator, enabling reduced-order predictions without solving the full governing equations. For systems with quadratic or cubic nonlinearities, POD combined with Galerkin projection provides a nonintrusive framework by projecting the dynamics onto empirical modes, where the nonlinear terms are evaluated in the reduced space, often further stabilized with techniques like DEIM for hyper-reduction. Integrations of , particularly neural networks for manifold learning, have advanced nonlinear since 2018 by learning nonlinear latent representations from . Autoencoders, for instance, serve as nonlinear dimensionality reducers, encoding high-dimensional states into low-dimensional embeddings and decoding them back, as demonstrated by and Maulik in 2020 for unsteady flows, where convolutional autoencoders capture complex nonlinear patterns more effectively than linear in predictions. These methods excel in capturing invariant manifolds underlying chaotic or turbulent dynamics, with post-2018 developments emphasizing to enforce conservation laws. Recent advances include Neural Galerkin schemes for nonlinear parametrizations that overcome Kolmogorov barriers in transport-dominated problems (as of 2025) and operator inference for nonintrusive learning of nonlinear reduced models from (reviewed in 2024). Simplified physics approaches, such as parameter lumping or spatial coarsening, reduce nonlinear PDE models by aggregating variables or discretizing on coarser while preserving key physical interactions. Lumping parameters treats spatially distributed nonlinear systems as interconnected lumped elements, as in the of reaction- PDEs where terms are spatially averaged to form equations (ODEs), reducing from thousands to dozens without significant in qualitative . Spatial coarsening, often via finite methods, merges grid cells for nonlinear conservation laws, enabling multiscale ROMs for PDEs like the Euler equations, with error controlled through adaptive refinement. These techniques are particularly effective for applications like chemical reactors, where they simplify geometry-dependent nonlinearities.

Error Estimation and Validation

Error Measures

Error measures in model order reduction quantify the discrepancy between the full-order model (FOM) and the reduced-order model (), ensuring the accurately captures the essential dynamics while minimizing approximation errors. These measures are crucial for assessing the fidelity of the process across , time, and domains. Common approaches include norm-based metrics derived from functions, residual-based a posteriori estimates, and bounds specific to reduction techniques like balanced truncation. Norm-based errors are widely used to evaluate the approximation quality in the . The H₂ norm measures the average energy of the error over all frequencies and is defined for the error H(s) - H_r(s) as \|H - H_r\|_2 = \sqrt{\frac{1}{2\pi} \int_{-\infty}^{\infty} |H(j\omega) - H_r(j\omega)|^2 \, d\omega}, which is particularly suitable for systems where root-mean-square error is of interest. In contrast, the H∞ norm captures the worst-case error magnitude, given by \|H - H_r\|_\infty = \sup_{\omega} \|H(j\omega) - H_r(j\omega)\|, emphasizing peak deviations that are critical for applications. These norms provide global assessments but can be computationally intensive for large-scale systems due to the need for frequency sweeps or solutions. For balanced truncation, a popular linear reduction method, the error is bounded using the Hankel norm, which relates to the system's and properties. The approximation error satisfies \|H - H_r\|_\infty \leq 2 \sum_{i=r+1}^n \sigma_i, where \sigma_i are the Hankel singular values in decreasing order, and r is the reduced order; this bound arises from the balanced realization where neglected modes contribute minimally to input-output behavior. This a priori estimate guides the selection of the reduction order by inspecting the decay of singular values. In reduced basis (RB) methods for parametrized systems, a posteriori error estimation relies on residual-based indicators to certify accuracy without recomputing the FOM solution. For instance, dual-weighted residuals provide goal-oriented bounds on output errors, decomposing the residual r(\mu) into components amenable to offline precomputation. A common greedy selection indicator is \eta(\mu) = \frac{\|r(\mu)\|}{\alpha(\mu)}, where \alpha(\mu) is a coercivity constant ensuring stability and rapid decay; this estimator drives adaptive basis enrichment while guaranteeing exponential convergence. Transient errors in time-domain simulations are often assessed via L₂ norms over the time interval, such as \|y(t) - y_r(t)\|_{L_2} = \sqrt{\int_0^T |y(t) - y_r(t)|^2 \, dt}, which quantifies cumulative deviation in responses; for problems, this extends to integrals over the space to ensure robustness across variations. Similarly, errors integrate L₂ norms over the , providing a measure of quality. To enable efficient evaluation in high-fidelity applications, error measures in RB frameworks employ offline-online : computationally expensive terms like norms and constants are precomputed offline in a high-dimensional space, while online phases rapidly assemble indicators for new parameters using the low-dimensional , achieving near-real-time certification with rigorous bounds.

Certification Methods

Validation workflows for reduced-order models (ROMs) typically involve cross-validation against full-order model (FOM) simulations to assess accuracy across a range of inputs and parameters. This process includes generating trajectories from the FOM and comparing predictions, often using data-driven correction techniques to refine the while ensuring consistency with high-fidelity simulations. Sensitivity analysis over model parameters is integrated to identify influential factors, guiding sample selection for parameterized and optimizing reduction efficiency without uniform grid sampling. Certification criteria emphasize rigorous guarantees for ROM reliability, particularly in linear systems. Stability certification often employs Lyapunov equations to derive error bounds that capture , providing time-stepping assurances even for noncoercive operators where traditional bounds are pessimistic. For passive systems, passivity checks verify that the ROM remains positive real, using methods like spectral zero to preserve and passivity during reduction. These criteria ensure the ROM maintains essential properties like and passivity, crucial for applications. Uncertainty quantification in ROMs incorporates model errors into probabilistic frameworks, such as Bayesian approaches that treat operator inference as an . Bayesian enables learnable ROMs with posterior distributions for operators, allowing sampling to propagate uncertainties from data noise or misspecification to predictions. This provides statistical moments for ROM outputs, enhancing reliability in data-driven settings like simulations. Recent developments as of 2025 include certified model order reduction for Hermitian eigenvalue problems, providing efficient approximations of smallest eigenvalues and eigenspaces with rigorous bounds, and the use of certified ROMs for stabilizing linear time-varying parabolic partial equations via receding horizon . These advances extend certification guarantees to more complex and dynamic scenarios. Best practices for ROM certification include an offline phase for constructing and bounding the model using FOM snapshots, followed by online deployment with efficient error estimators to monitor performance in . Dual-weighted residual methods or randomized estimators facilitate error assessment, ensuring computational efficiency. In cases of certification failure, adaptive enrichment techniques iteratively refine the ROM basis by adding snapshots from sensitive regions, restoring guarantees without full recomputation. In industries like aerospace, standards such as DO-178C guide ROM certification by requiring verifiable software processes for safety-critical systems, including traceability and verification objectives applicable to model-based reductions. This ensures ROMs meet design assurance levels through rigorous planning, development, and integral processes, aligning with airborne equipment certification needs.

Applications

Engineering Systems

In engineering systems, model order reduction (MOR) plays a crucial role in managing the complexity of high-fidelity models derived from finite element analyses or circuit simulations, enabling efficient design, control, and optimization of mechanical, electronic, and control components. By approximating large-scale systems with lower-dimensional equivalents while preserving essential dynamics, MOR facilitates real-time applications and iterative processes that would otherwise be computationally prohibitive. This is particularly evident in domains like control systems, where reduced models support robust controller synthesis, and in electronics, where they accelerate timing and signal integrity assessments. In control systems, is essential for real-time controller design, especially for flexible structures where high-order models from discretized partial differential equations hinder implementation. For instance, in active control of flexible structures, H∞-based controllers are derived using balanced truncation on a 48th-order plant model, achieving comparable suppression with H∞ norms indicating robust and minimal performance degradation. This reduction enables practical deployment in systems like structures or robotic arms, where computational constraints demand low-order controllers without sacrificing robustness to uncertainties. In and , MOR techniques address the challenges of interconnect delays in very-large-scale (VLSI) chips, where networks can exceed thousands of nodes. The asymptotic waveform evaluation () method approximates the transfer functions of these distributed trees via Padé synthesis, reducing models from high orders (often involving 10^3 to 10^5 nodes) to low-order equivalents (typically order 2 to 10) with negligible error in transient waveforms and delays. This allows for rapid analysis of signal propagation and in high-speed circuits, speeding up simulations by two to three orders of magnitude compared to full transient solvers. For , modal methods provide an effective approach for analysis in large-scale artifacts such as and , where eigenvalue problems dominate the computational burden. Techniques like modal truncation retain dominant eigenmodes (up to twice the maximum frequency of interest) to form reduced bases, transforming finite element models with millions of into compact representations that accurately capture resonant behaviors. Component mode synthesis further enhances this by substructuring the system—e.g., treating components separately—and combining fixed-interface modes with constraint modes, reducing overall size while enabling mid-frequency predictions for , harshness, and (NVH) assessments in automotive frames or seismic response in high-rise . Filtration of low-contribution constraint modes can further cut model density by up to 84%, preserving accuracy for optimization tasks. In devices, MOR integrates coupled electro-thermal-mechanical to support under multiphysics interactions, such as in microgrippers or actuators where induces thermal stresses and deflections. methods like Arnoldi extraction generate reduced models from finite element discretizations, automating basis selection via error bounds and deflation for , achieving up to 85% time savings compared to full-order analyses while maintaining dynamic . These reduced models enable sweeps for or variations, facilitating reliable predictions in electrothermal actuators without excessive computational overhead. A notable involves automotive crash simulations, where () reduces nonlinear finite element models for faster post-2010. In a bumper system overlap crash analyzed via , POD with hyper-reduction (selecting 3.5% of elements via energy thresholding) lowered a model with 22,498 deformable elements to an effective 30-mode basis, cutting runtime from 49 minutes to 5 minutes per simulation with only 2.5% displacement error. This enables optimization of —e.g., varying material thicknesses or geometries—accelerating robustness studies and cycles by factors of 5 to 10, as demonstrated in full-vehicle frontal impacts.

Scientific Simulations

In scientific simulations governed by partial differential equations (PDEs), model order reduction (MOR) techniques enable efficient analysis of complex physical phenomena by approximating high-fidelity models with lower-dimensional representations while preserving essential dynamics. A prominent application is in , where (POD) combined with Galerkin reduces the Navier-Stokes equations for turbulent flows. This approach extracts dominant modes from snapshot data of high-resolution simulations, projecting the governing equations onto a low-dimensional to capture energy-containing structures in turbulent regimes. Seminal work demonstrated that POD-Galerkin models effectively approximate unsteady turbulent flows by retaining only the most energetic modes, achieving significant computational savings without substantial loss in predictive accuracy for long-time integrations. A notable example in aerospace-related fluid simulations involves the aeroelastic analysis of an F-16 aircraft configuration, where the full-order model combines a finite element structural model with 168,799 and an Euler (CFD) model exceeding 2 million . Using POD-Galerkin reduction, local reduced-order models were constructed from snapshots at sampled numbers and interpolated parametrically, yielding aeroelastic ratio estimates in good agreement with the full model. This reduction facilitated rapid parametric studies of flutter boundaries, highlighting POD's utility for high-dimensional turbulent flow problems in scientific contexts. In and modeling, parametric reduced-order models (ROMs) accelerate predictions by approximating global circulation models (GCMs), which typically involve millions of grid points and parameters representing atmospheric physics. Techniques like POD or project the or full GCM dynamics onto low-dimensional manifolds, enabling through large s at reduced cost. For instance, ROMs have been applied to parametrized GCMs for of patterns, where the reduced models capture variability in and while speeding up simulations by orders of magnitude compared to full-resolution runs. Such approaches are particularly valuable for long-term projections, where repeated evaluations over parameter spaces assess to conditions or forcings. Quantum chemistry simulations benefit from MOR to approximate density functional theory (DFT) calculations in molecular dynamics, where iterative electronic structure solves dominate computational expense. A recent MOR framework learns a low-dimensional representation of the Kohn-Sham orbitals from trajectory snapshots, projecting the DFT Hamiltonian to bypass repeated self-consistent field iterations while maintaining accuracy in energy and forces. Applied to systems like water molecules under thermal fluctuations, this method achieves errors below 1% in molecular properties relative to full DFT, enabling longer-time-scale simulations of quantum mechanical dynamics in complex environments. For wave propagation in acoustics and electromagnetics, methods reduce frequency-domain models for efficient sweeps across broad spectra, crucial for simulating sound or interactions in media. These techniques generate orthogonal bases from moment-matching projections of the discretized wave equations, yielding reduced models that preserve passivity and stability for parametric frequency analyses. In acoustic problems, rational Krylov reduction compresses boundary element models by factors of 100 or more, allowing rapid evaluation of transfer functions over decades of frequencies with errors under 1 . Similarly, in electromagnetics, extended Krylov methods handle dispersive materials in time- or frequency-domain simulations of wave propagation, as demonstrated in where full-wave models with millions of unknowns are reduced to hundreds. A from geosciences illustrates MOR's impact on oil simulations for matching in the . In fractured reservoirs, combined with discrete empirical interpolation method (DEIM) reduces trajectory-piecewise linear (TPWL) models of , accelerating forward simulations by 90% while matching production data like pressure and saturation profiles. For a field-scale model with over 1 million grid blocks, the ROM integrated into an ensemble Kalman filter framework updated permeability and porosity parameters, achieving a 20% improvement in match quality over full-order runs, as validated against synthetic and real-field data from Permian Basin analogs. This application underscores MOR's role in enabling real-time inverse modeling for management.

Software and Implementations

Open-Source Tools

Several open-source tools have emerged to support the implementation of model order reduction (MOR) techniques, offering freely accessible, community-maintained software that integrates with popular scientific computing frameworks. These tools emphasize modularity, extensibility, and compatibility with high-performance computing, enabling researchers to apply MOR to parametric systems, dynamical models, and data-driven analyses without proprietary dependencies. By providing pre-implemented algorithms for projection-based, modal, and certified methods, they lower barriers to experimentation and validation in fields like engineering and scientific computing. pyMOR is a comprehensive designed for developing applications, with a focus on reduced basis methods and (POD) tailored to parametric partial differential equations (PDEs). It supports the offline-online decomposition paradigm, allowing efficient construction of reduced models from high-fidelity discretizations. pyMOR includes bindings for integrating with finite element libraries such as FEniCS and its DOLFIN backend, facilitating the wrapping of assembled forms and vectors for MOR workflows. This integration enables users to leverage existing PDE solvers while applying MOR operators like Galerkin projections directly within environments. MORLAB is a and Octave-compatible toolbox that implements MOR for linear dynamical systems through the numerical solution of matrix equations, emphasizing structure-preserving reductions. It provides routines for balanced truncation, which minimizes the Hankel norm error by balancing and Gramians, and the iterative rational Krylov (IRKA), an optimization-based method for H2-optimal rational . These features make MORLAB suitable for reducing large-scale linear time-invariant systems, including descriptor models, with options for frequency-weighted and positive real approximations. PyDMD offers a implementation of (DMD), a data-driven MOR approach that approximates nonlinear dynamics via linear modal decompositions from time-series snapshots. The library includes variants such as optimized DMD, sparse DMD, and physics-informed DMD, which handle noisy, multiscale, or constrained data while extracting spatiotemporal coherent structures. PyDMD supports forward prediction, , and applications by computing eigenvalues and modes that capture dominant behaviors in high-dimensional datasets. libROM is a lightweight, scalable C++ and library for intrusive and data-driven ROMs, with emphasis on projection-based techniques in multifidelity modeling frameworks. It facilitates POD-Galerkin reductions and supports hyper-reduction methods like empirical for nonlinear systems, enabling efficient handling of varying fidelity levels in simulations. Developed at , libROM has been utilized in high-fidelity applications such as hypersonic flow simulations, where it accelerates parametric studies through parallelizable ROM assembly. Recent advancements in pyMOR, as of its 2025 releases, incorporate for non-intrusive MOR, extending artificial neural network-based reductions to non-stationary and nonlinear models to create hybrid ROMs that blend data-driven and physics-based elements. This integration enhances pyMOR's capabilities for handling , such as those in time-dependent PDEs, by training surrogate operators that preserve .

Commercial and Specialized Software

Commercial software for model order reduction (MOR) provides robust, certified implementations tailored for industrial applications, emphasizing integration with workflows, scalability for large-scale systems, and validation features to ensure reliability in production environments. These tools often include algorithms that support linear and nonlinear reductions, with licensing models that enable enterprise-wide deployment and . In and , the Control System Toolbox features the balred function, which performs balanced truncation to compute reduced-order approximations of linear time-invariant (LTI) models by specifying the desired order and preserving key dynamic characteristics. Extensions in facilitate seamless incorporation of reduced models into multidomain simulations, enhancing efficiency for design. software supports MOR for and multiphysics finite element analysis (FEA), enabling the creation of reduced-order models (ROMs) that simplify complex simulations while maintaining accuracy for . For nonlinear problems, hyper-reduction techniques in Mechanical reduce computational costs in FEA by approximating nonlinear terms, particularly useful in and analyses. COMSOL Multiphysics includes a dedicated Model Reduction node under the Reduced-Order Modeling study option, which generates ROMs from (PDE)-based simulations by projecting high-fidelity models onto lower-dimensional subspaces. This integrates with parametric sweeps to efficiently evaluate model behavior across parameter ranges, accelerating multiphysics studies in areas like electromagnetics and fluid flow. Siemens Simcenter Amesim offers system-level MOR capabilities, allowing engineers to build and export ROMs from high-fidelity simulations to speed up mechatronic system analysis in automotive and domains. The platform emphasizes validation against test data, supporting scalable implementations for prototyping. Specialized tools for , such as those employing algebraic reduction methods, focus on interconnect and RCL models to minimize order while preserving passivity and . Recent advancements (2024–2025) integrate into MOR workflows for automated certification and surrogate modeling, enhancing accuracy in model-based development for electric vehicles and beyond. These licensed solutions prioritize certified outputs for and integration.

References

  1. [1]
    [PDF] Introduction to Model Order Reduction
    Many different research communities use different forms of model reduction: Fluid dynamics. Mechanics. Computational biology. Circuit design. Control theory … • ...
  2. [2]
    [PDF] An Introduction to Model Order Reduction: - mediaTUM
    Jun 5, 2018 · •. Numerical Examples, FEM & MOR software. II. Polynomial & Nonlinear Model Order Reduction. •. Projective NLMOR, Overview NLMOR methods.
  3. [3]
    [PDF] Model Order Reduction - OAPEN Library
    This second volume of the Model Order Reduction handbook project mostly focuses on snapshot-based methods for parameterized partial differential equations.
  4. [4]
    Model Order Reduction Techniques with Applications in Finite ...
    Model order reduction methods reduce computational cost for complex models, and this book explains and compares techniques like dynamic condensation.Missing: discretization | Show results with:discretization
  5. [5]
    A Survey of Projection-Based Model Reduction Methods for ...
    This paper surveys state-of-the-art methods in projection-based parametric model reduction, describing the different approaches within each class of methods.<|control11|><|separator|>
  6. [6]
    Model order reduction of finite element models: improved ...
    Because of increased accuracy requirements, the FE method results in discretized models, which are described by higher order ordinary differential equations, or ...
  7. [7]
    [PDF] Parametric Model Order Reduction for Structural Analysis and Control
    During the recent several decades, model order reduction has been investigated for simulation, control, and optimization of mechanical and electrical systems.
  8. [8]
    Reduction of stiffness and mass matrices | AIAA Journal
    Automatic order reduction of thermo-electric models for MEMS: Arnoldi versus Guyan. 1 Jan 2002. Condensed joint matrix method for the joint structure of a ...
  9. [9]
    Principal component analysis in linear systems: Controllability ...
    Abstract: Kalman's minimal realization theory involves geometric objects (controllable, unobservable subspaces) which are subject to structural instability.
  10. [10]
    Model reduction methods based on Krylov subspaces | Acta Numerica
    Jul 29, 2003 · This paper reviews the main ideas of reduced-order modelling techniques based on Krylov subspaces and describes some applications of reduced-order modelling in ...
  11. [11]
    (PDF) Machine Learning Approach to Model Order Reduction of ...
    Sep 23, 2021 · These are used for creating an nonlinear reduced-order model (ROM) of the system, able to recreate the full system's dynamic response under a ...
  12. [12]
    [PDF] A survey of model reduction methods for large-scale systems - People
    Oct 27, 2006 · Abstract. An overview of model reduction methods and a comparison of the resulting algorithms is presented.
  13. [13]
    Approximation of Large-Scale Dynamical Systems
    Approximation of Large-Scale Dynamical Systems provides a comprehensive picture of model reduction, combining system theory with numerical linear algebra and ...
  14. [14]
    (PDF) Model order reduction of linear time invariant systems
    This paper addresses issues related to the order reduction of systems with multiple input/output ports. The order reduction is divided up into two steps. The ...
  15. [15]
    [PDF] Reduced-order Modelling Of Linear Time-varying Systems
    TVP provides the reduced model as a. LTI system followed by a memoryless mixing operation; this makes it easy to incorporate the macromodel in existing circuit ...
  16. [16]
    [PDF] Model order reduction for nonlinear dynamical systems based on ...
    In this paper we focus on discussing model order reduction strategies for nonlin- ear dynamical systems in the following state-space form: ˙x = f (x) + Bu ...
  17. [17]
    Model Order Reduction for Water Quality Dynamics - AGU Journals
    Mar 9, 2022 · This paper focuses on seeking proper SVD-based model reduction methods for the water quality dynamics represented linear discrete-time systems ...<|control11|><|separator|>
  18. [18]
    [PDF] REDUCED ORDER MODEL PREDICTIVE CONTROL OF HIGH ...
    In this thesis, we propose an approach for efficiently designing high-performing controllers based on high-dimensional models. Specifically, we develop a model ...
  19. [19]
    [PDF] model reduction for large-scale systems with high-dimensional ...
    Abstract. A model-constrained adaptive sampling methodology is proposed for reduction of large-scale systems with high-dimensional parametric input spaces.
  20. [20]
    [PDF] Reduced Basis Methods: Success, Limitations and Future Challenges
    Jan 8, 2016 · Parametric model order reduction using reduced basis methods can be an effective tool for obtaining quickly solvable reduced order models of.
  21. [21]
    [PDF] Reduced Basis Methods: Affine Decomposition
    The reduced basis method requires operators with affine parameter de- pendence. Non-affine and nonlinear operators must have their parameter dependent ...
  22. [22]
    [PDF] Gramian based model reduction for descriptor systems 1 Introduction
    The number of state variables n is called the order of system (1.1). If I = E, then (1.1) is a standard state space system. Otherwise, (1.1) is a descriptor ...
  23. [23]
  24. [24]
  25. [25]
  26. [26]
  27. [27]
    A New Selection Operator for the Discrete Empirical Interpolation ...
    This paper introduces a new framework for constructing the discrete empirical interpolation method (\sf DEIM) projection operator.Missing: QDEIM | Show results with:QDEIM
  28. [28]
    A trajectory piecewise-linear approach to model order reduction and ...
    In this paper, we present an approach to nonlinear model reduction based on representing a nonlinear system with a piecewise-linear system and then reducing ...Missing: seminal | Show results with:seminal
  29. [29]
    Nonlinear Model Order Reduction via Dynamic Mode Decomposition
    Specifically, we advocate the use of the recently developed dynamic mode decomposition (DMD), an equation-free method, to approximate the nonlinear term.
  30. [30]
    Deep neural networks for nonlinear model order reduction of ...
    Oct 1, 2020 · An autoencoder network is used for nonlinear dimension reduction and feature extraction as an alternative for singular value decomposition (SVD) ...
  31. [31]
    (PDF) Nonlinear model order reduction of Burgers' Equation using ...
    Aug 7, 2025 · The derived lumped-parameter model for Burgers' equation is then described by a nonlinear state-space model.
  32. [32]
    [PDF] A New Framework for H2-Optimal Model Reduction - arXiv
    Sep 21, 2017 · In this contribution, we address the problem of finding an optimal ROM of prescribed order n that minimizes the error measured in the H2 norm, ...
  33. [33]
    [PDF] Reduced Basis Approximation and A Posteriori Error Estimation for ...
    Mar 2, 2007 · This book evaluates input-output relationships in input-parameterized PDEs, focusing on mechanics, and builds upon finite element approximation.
  34. [34]
    [PDF] L2-optimal Reduced-order Modeling Using Parameter ... - arXiv
    Oct 17, 2022 · We provide a unifying framework for L2-optimal reduced-order modeling for linear time-invariant dynamical systems and stationary parametric ...
  35. [35]
    Cross-Validation of Data-Driven Correction Reduced Order Modeling
    In this thesis, we develop a data-driven correction reduced order model (DDC-ROM) for numerical simulation of fluid flows ... full order model (FOM) and construct ...
  36. [36]
    Sample selection based on sensitivity analysis in parameterized ...
    Thus a model order reduction is required to decrease the dimensionality and to enable an efficient numerical simulation. In addition, methods of parameterized ...
  37. [37]
    Lyapunov-Based Error Bounds for the Reduced-Basis Method
    Our new bounds are time-stepping bounds that make use of the Lyapunov stability theory to better capture the dynamics of the system. Previous article in issue
  38. [38]
    Passivity Preserving Model Order Reduction Using the Reduce ...
    The reduced order results indicate preservation of passivity and greater accuracy than the other model order reduction methods.Missing: objectives | Show results with:objectives
  39. [39]
    Bayesian Proper Orthogonal Decomposition for Learnable Reduced ...
    Apr 20, 2023 · In this paper, we propose such a novel framework of Bayesian reduced-order models naturally equipped with uncertainty quantification.
  40. [40]
    [PDF] Bayesian operator inference for data-driven reduced-order modeling
    Jul 1, 2022 · The objective of this work is to enable uncertainty quantification for data-driven reduced-order modeling. A reduced-order model (ROM) is a low ...
  41. [41]
    Certified Model Order Reduction
    This project aims at certified model order reduction of coupled mechanical systems. Coupled mechanical systems are generally high dimensional nonlinear ...
  42. [42]
    Well‐scaled, a‐posteriori error estimation for model order reduction ...
    Jun 25, 2020 · Model Order Reduction is used to vastly speed up simulations but it also introduces an error to the simulation results, which needs to be ...
  43. [43]
    DO-178() Software Standards Documents & Training - RTCA
    DO-178(), originally published in 1981, is the core document for defining both design assurance and product assurance for airborne software.Missing: order reduction
  44. [44]
    Design and Tuning of Reduced Order H-Infinity Feedforward ...
    Mar 17, 2011 · A controller order reduction technique is proposed for reducing the complexity of the nominal H∞ controller without degrading the performance.
  45. [45]
    A comparative study on H-infinity based vibration controller of a ...
    Abstract: Presents a method of controlling the first three vibration modes of a flexible structure using H-infinity optimal control.
  46. [46]
    Analysis of high-speed VLSI interconnects using the asymptotic ...
    The asymptotic waveform evaluation (AWE) technique provides a generalized approach to lumped RLC circuit response approximations. Two results are described: ...
  47. [47]
    Vibration and Optimization Analysis of Large-Scale Structures using ...
    Section 2 presents an overview of reduced-order modeling and substructuring methods including modal reduction and component mode synthesis (CMS). Improvements ...Missing: buildings | Show results with:buildings<|control11|><|separator|>
  48. [48]
    Interpolation‐based parametric model order reduction of automotive ...
    Feb 28, 2023 · In the field of brake analysis, the modal truncation method is typically used for the reduction. Here, the behavior of the system is ...
  49. [49]
    Coupled electrothermal–mechanical analysis for MEMS via model ...
    This paper investigates model order reduction (MOR) techniques that can be used in conjunction with finite element schemes to generate computationally ...
  50. [50]
    [PDF] Dimensionality reduction of crash and impact simulations using LS ...
    Jun 6, 2019 · It is based on the singular value decomposition. (SVD), equivalently known as Proper Orthogonal Decomposition (POD) or Principal Component. Analysis (PCA). It ...
  51. [51]
    Reduced-order fluid/structure modeling of a complete aircraft ...
    Reduced-order fluid/structure modeling of a complete aircraft configuration ... Farhat, P. Geuzaine, G. Brown. Application of a three-field non-linear fluid ...Missing: Lieu Farhat
  52. [52]
    Reduction methods in climate dynamics—A brief review
    We present a brief but broad overview of reduction methods applicable to climate dynamics. Each method is illustrated using a model example.
  53. [53]
    [PDF] Reduced Order Models for the Quasi-Geostrophic Equations
    Dec 31, 2020 · Abstract: Reduced order models (ROMs) are computational models whose dimension is significantly lower than those obtained through classical ...
  54. [54]
    Model Order Reduction for Quantum Molecular Dynamics - arXiv
    Sep 9, 2025 · The paper proposes a model order reduction approach for quantum molecular dynamics, learning a low-dimensional representation to avoid ...
  55. [55]
    Review and assessment of interpolatory model order reduction ...
    May 21, 2012 · Frequency sweeps in structural dynamics, acoustics, and vibro-acoustics require evaluating frequency response functions for a large number ...Missing: propagation | Show results with:propagation
  56. [56]
    An Extended Krylov Subspace Model-Order Reduction Technique to ...
    Feb 27, 2014 · In this paper we present a novel extended Krylov subspace reduced-order modeling technique to efficiently simulate time- and frequency-domain ...
  57. [57]
    Reduced-Order Modeling for Fractured Reservoir Simulation by Use ...
    Oct 1, 2025 · The objective of this study is to present a novel reduced-order model (ROM) approach for accelerating the flow simulation of fractured ...
  58. [58]
    pyMOR | Model Order Reduction with Python
    pyMOR is a software library for building model order reduction applications with the Python programming language.pyMOR · Developer Documentation · Technical Overview · Tutorials
  59. [59]
    pyMOR - Generic Algorithms and Interfaces for Model Order Reduction
    Jun 23, 2015 · In this work we discuss the design of pyMOR, a freely available software library of model order reduction algorithms, in particular reduced basis methods.<|control11|><|separator|>
  60. [60]
    pymor.bindings.fenics
    Wraps a parameterized FEniCS linear or bilinear form as an Operator . Parameters: form – The Form object which is assembled to a matrix or vector.Missing: integration | Show results with:integration
  61. [61]
    pyMOR - GitLab
    Jan 28, 2019 · pyMOR has been designed with easy integration of external PDE solvers in mind. We provide bindings for the following solver libraries: FEniCS.
  62. [62]
    MORLAB - Institut Magdeburg - Max-Planck-Gesellschaft
    The MORLAB toolbox is a collection of MATLAB routines for model order reduction of dynamical systems based on the solution of matrix equations.
  63. [63]
    [PDF] Optimal model reduction by tangential interpolation - mediaTUM
    Aug 10, 2018 · -approximation error of IRKA and balanced truncation. Once a set of favorable interpolation conditions is found, the only remaining degrees ...
  64. [64]
    [PDF] MATLAB Toolboxes for Model Order Reduction of Large-scale ...
    Mar 10, 2020 · • MORLAB (MATLAB/Octave) offers modal and balanced truncation (several balancing variants, coverage of descriptor systems, special variants ...
  65. [65]
  66. [66]
    A Software Framework for Reduced Basis Methods Using Dune-RB ...
    For both settings, model order reduction by the reduced basis approach is a suitable means to reduce computational time. The method is based on a projection ...
  67. [67]
    [PDF] A Software Framework for Reduced Basis Methods using DUNE-RB ...
    For both settings, model order reduc- tion by the reduced basis approach is a suitable means to reduce computational time. The method is based on a ...
  68. [68]
    [PDF] Model Order Reduction Methods in Computational Uncertainty ...
    Sep 28, 2015 · Dune-RB: It is a module for the Dune (Distributed and Unified Numerics Environment) library in C++. Template classes are available for RB ...
  69. [69]
    libROM - Data-driven Modeling Library
    libROM is a free, lightweight, scalable C++ library for data-driven physical simulation methods. It is the main tool box that the reduced order modeling team ...Building libROM · Features · DDPS · ScaleupROM
  70. [70]
    LLNL/libROM: Data-driven model reduction library with an ... - GitHub
    libROM is a free, lightweight, scalable C++ library for data-driven physical simulation methods from the intrusive projection-based reduced order models.
  71. [71]
    libROM | Computing - Lawrence Livermore National Laboratory
    libROM is a library designed to facilitate Proper Orthogonal Decomposition (POD) based Reduced Order Modeling (ROM). In POD ROM one attempts to represent ...
  72. [72]
    Release Notes — pyMOR v2025.1.1 Manual
    This release extends pyMOR's support for non-intrusive model reduction via artificial neural networks to non-stationary models. Built-in ...Missing: hybrid | Show results with:hybrid
  73. [73]
    Available MOR methods — pyMOR v2025.1.2 Manual
    Sep 10, 2025 · Here we give an overview over (most of) the available MOR methods implemented in pyMOR. We provide short code snippets that show how to use ...Missing: integration hybrid
  74. [74]
    balred - (Not recommended) Model order reduction - MATLAB
    Computes a reduced-order approximation rsys of the LTI model sys. The desired order (number of states) is specified by order.
  75. [75]
    Simplify Simulation with Reduced-order Modeling - Ansys
    Jun 10, 2025 · Reduced-order models (ROMs) are simplifications of complex models that capture the behavior of source models so engineers and designers can quickly study a ...Missing: MOESS | Show results with:MOESS
  76. [76]
    A hyper-reduction computational method for accelerated modeling ...
    A hyper-reduced-order method is introduced for the accelerated modeling of thermal cycling-induced plastic deformation.
  77. [77]
    Model Reduction
    To add a Model Reduction node, first select Reduced-Order Modeling in the Show More Options dialog box. There can only be one Model Reduction node in a study.
  78. [78]
    Reduced Order Model for simulation speed-up with Simcenter Amesim
    Dec 10, 2020 · In this article, I'll try to explain what the most common causes of slow simulations are, and how to use Reduced Order Model for simulation speed-up.
  79. [79]
    2024-01-2850 : Reduced Order Modeling Technology with AI for ...
    Apr 8, 2024 · This paper introduces reduced-order modeling techniques with Artificial Intelligence (AI) for Model-Based Development (MBD).