Skip to main content

Computer Physics Communications

ISSN: 0010-4655

Visit Journal website

Datasets associated with articles published in Computer Physics Communications

Filter Results
1970
2025
1970 2025
6038 results
  • SMIwiz-2.0: Extended functionalities for wavefield decomposition, linearized and nonlinear inversion
    We extend the functionalities of SMIwiz open source software to include up-down wavefield separation, reflection waveform inversion, as well as linearized waveform inversion in data and image domain. The fundamental functionalities for 2D/3D wave modelling and imaging (reverse time migration and nonlinear full waveform inversion) are backward compatible with improvements in seismic imaging processing. Reproducible examples are supplied to verify these developments.
    • Dataset
  • CUBENS: A GPU-accelerated high-order solver for wall-bounded flows with non-ideal fluids
    We present a massively parallel GPU-accelerated solver for direct numerical simulations of transitional and turbulent flat-plate boundary layers and channel flows involving fluids in non-ideal thermodynamic states. While several high-fidelity solvers are currently available as open source, all of them are restricted to the ideal-gas region. In contrast, the CUBic Equation of state Navier-Stokes solver (CUBENS) can accurately model and simulate the non-ideal thermodynamics of single-phase compressible fluids in the vicinity of the vapor-liquid saturation line or the thermodynamic critical point. By employing high-order finite-difference schemes and convective terms in split, kinetic-energy-, and entropy-preserving form, the solver is numerically stable, and robust with minimal numerical dissipation, enabling it to capture the steep variations of non-ideal thermodynamic properties. For cost-effective high-fidelity simulations, in addition to MPI parallelization, CUBENS is GPU-accelerated using OpenACC directives for computation offloading, and asynchronous GPU-aware MPI for efficient GPU-GPU communication. Moreover, CUBENS is compatible with both NVIDIA and AMD GPU architectures, achieving significant performance results while ensuring energy-efficient simulations. For instance, using 64 NVIDIA A100 GPUs compared to 8192 CPUs at the same computational cost results in a speedup of approximately 130×. In multi-node and multi-GPU configurations ranging from 2 to 128 compute nodes (8 to 512 GPUs), a strong scaling efficiency of around 52% and a weak scaling efficiency of 0.88 with 10243 points per GPU, corresponding to approximately 5 billion degrees of freedom, are achieved. The CUBENS solver is validated against selected cases from the literature, covering transitional to turbulent ideal and non-ideal flows up to the transonic regime. In particular, we demonstrate the solver's suitability and applicability for direct numerical simulations of transitional boundary layers with fluids at supercritical pressure and with buoyancy effects. The development of this high-fidelity solver offers the potential for future fundamental research in non-ideal compressible fluid dynamics.
    • Dataset
  • LibRPA: A software package for low-scaling first-principles calculations of random phase approximation electron correlation energy based on numerical atomic orbitals
    LibRPA is a software package designed for efficient calculations of random phase approximation (RPA) electron correlation energies from first principles using numerical atomic orbital (NAOs). Leveraging a localized resolution of identity (LRI) technique, LibRPA achieves O(N^2) or better scaling behavior, making it suitable for large-scale calculation of periodic systems. Implemented in C++ and Python with MPI/OpenMP parallelism, LibRPA integrates seamlessly with NAO-based density functional theory (DFT) packages through flexible file-based and API-based interfaces. In this work, we present the theoretical framework, algorithm, software architecture, and installation and usage guide of LibRPA. Performance benchmarks, including the parallel efficiency with respect to the computational resources and the adsorption energy calculations for H20 molecules on graphene, demonstrate its nearly ideal scalability and numerical reliability. LibRPA offers a useful tool for RPA-based calculations for large-scale extended systems.
    • Dataset
  • JuTrack: A Julia package for auto-differentiable accelerator modeling and particle tracking
    Efficient accelerator modeling and particle tracking are key for the design and configuration of modern particle accelerators. In this work, we present JuTrack, a nested accelerator modeling package developed in the Julia programming language and enhanced with compiler-level automatic differentiation (AD). With the aid of AD, JuTrack enables rapid derivative calculations in accelerator modeling, facilitating sensitivity analyses and optimization tasks. We demonstrate the effectiveness of AD-derived derivatives through several practical applications, including sensitivity analysis of space-charge-induced emittance growth, nonlinear beam dynamics analysis for a synchrotron light source, and lattice parameter tuning of the future Electron-Ion Collider (EIC). Through the incorporation of automatic differentiation, this package opens up new possibilities for accelerator physicists in beam physics studies and accelerator design optimization.
    • Dataset
  • HTMPC: A heavily templated C++ library for large scale particle-based mesoscale hydrodynamics simulations using multiparticle collision dynamics
    We present HTMPC, a Heavily Templated C++ library for large-scale simulations implementing multi-particle collision dynamics (MPC), a particle-based mesoscale hydrodynamic simulation method. The implementation is plugin-based, and designed for distributed computing over an arbitrary number of MPI ranks. By abstracting the hardware-dependent parts of the implementation, we provide an identical application-code base for various architectures, currently supporting CPUs and CUDA-capable GPUs. We have examined the code for a system of more than a trillion MPC particles distributed over a few thousand MPI ranks (GPUs), demonstrating the scalability of the implementation and its applicability to large-scale hydrodynamic simulations. As showcases, we examine passive and active suspension of colloids, which confirms the extensibility and versatility of our plugin-based implementation.
    • Dataset
  • EllipsoidalFiberFoam, a novel Eulerian-Lagrangian solver for resolving translational and rotational motion dynamics of ellipsoidal fibers
    A novel Eulerian-Lagrangian MPI parallelized solver is developed to resolve the dynamics of ellipsoidal fibers in the OpenFOAM platform. Due to the nonspherical shape of the ellipsoidal fibers and the dependence of the drag force on the orientation of the fiber, the solver solves the full conservation of linear and angular momentum equations, in addition to the time evolution equation for Euler's parameters, quaternions. To this end, a new parcel type is introduced to represent ellipsoidal fibers with several new properties, including Euler's parameters, angular velocity, and torque class. Finally, new member functions are defined to solve angular momentum and Euler's parameters time evolution equations. The solver is the first publicly available, robust and reliable computational framework for the numerical analysis of ellipsoidal fibers motion. It promotes the capability of the standard Lagrangian OpenFOAM solvers and libraries to capture the orientation and rotational dynamics of nonspherical particles. As validation cases, the solver was applied to four benchmarks: three-dimensional rotation of an ellipsoid in linear shear flow, two-dimensional rotation of a magnetic ellipsoid in linear shear flow subjected to a uniform magnetic field, motion of an ellipsoid in pipe flow, and ellipsoids deposition in three-dimensional bifurcation flow. Comparison of the results with analytical solutions, experimental data and in-silico results indicates close agreements and high accuracy of the developed numerical model for single- and multi-physics test cases.
    • Dataset
  • TrussMe-Fem: A toolbox for symbolic-numerical analysis and solution of structures
    Structural mechanics is pivotal in comprehending how structures respond to external forces and imposed displacements. Typically, the analysis of structures is performed numerically using the direct stiffness method, which is an implementation of the finite element method. This method is commonly associated with the numerical solution of large systems of equations. However, the underlying theory can also be conveniently used to perform the analysis of structures either symbolically or in a hybrid symbolic-numerical fashion. This approach is useful to mitigate the computational burden as the obtained partial or full symbolic solution can be simplified and used to generate lean code for efficient simulations. Nonetheless, the symbolic direct stiffness method is also useful for model reduction purposes, as it allows the derivation of small-scale models that can be used for diminishing simulation time. Despite the mentioned advantages, symbolic computation carries intrinsically complex operations. In particular, the symbolic solution of large linear systems of equations is hard to compute, and it may not always be available due to software capabilities. This paper introduces a toolbox named TrussMe-Fem, whose implementation is based on the direct stiffness method. TrussMe-Fem leverages Maple®'s symbolic computation and Matlab®'s numerical capabilities for symbolic and hybrid symbolic-numerical analyses and solutions of structures. Efficient code generation is also possible by exploiting the simplification of the problem's expressions. The challenges posed by symbolic computation on the solution of large linear systems are addressed by introducing novel routines for the symbolic matrix factorization with the hierarchical representation of large expressions. For this purpose, the TrussMe-Fem toolbox optionally uses the Lem and Last Maple® packages, which are also available as open-source software.
    • Dataset
  • Numerical analysis and integration of dynamical systems and the fractal dimension of boundaries
    The set of Maple routines that comprises the package Ndynamics has been improved. Apart one of the main motivations for its creation, namely, the routines to calculate the fractal dimension of boundaries (via box counting), the package deals with the numerical evolution of dynamical systems and provide flexible plotting of the results. The package also brings an initial conditions generator, a numerical solver manager, and a focusing set of routines that allow for better analysis of the graphical display of the results. Many new Maple-in-built numerical solvers are now programmed and available for the user of the package. The novelty that the package presented at the time of its release, an optional numerical interface, is maintained and updated.
    • Dataset
  • An unstructured geometrical un-split VOF method for viscoelastic two-phase flows
    Since viscoelastic two-phase flows arise in various industrial and natural processes, developing accurate and efficient software for their detailed numerical simulation is a highly relevant and challenging research task. We present a geometrical unstructured Volume-of-Fluid (VOF) method for handling two-phase flows with viscoelastic liquid phase, where the latter is modeled via generic rate-type constitutive equations and a one-field description is derived by conditional volume averaging of the local instantaneous bulk equations and interface jump conditions. The method builds on the plicRDF-isoAdvector geometrical VOF solver that is extended and combined with the modular framework DeboRheo for viscoelastic computational fluid dynamics (CFD). A piecewise-linear geometrical interface reconstruction technique on general unstructured meshes is employed for discretizing the viscoelastic stresses across the fluid interface. DeboRheo facilitates a flexible combination of different rheological models with appropriate stabilization methods to address the high Weissenberg number problem.
    • Dataset
  • AMEP: The active matter evaluation package for Python
    The Active Matter Evaluation Package (AMEP) is a Python library for analyzing simulation data of particle-based and continuum simulations. It provides a powerful and simple interface for handling large data sets and for calculating and visualizing a broad variety of observables that are relevant to active matter systems. Examples range from the mean-square displacement and the structure factor to cluster-size distributions, binder cumulants, and growth exponents. AMEP is written in pure Python and is based on powerful libraries such as NumPy, SciPy, Matplotlib, and scikit-image. Computationally expensive methods are parallelized and optimized to run efficiently on workstations, laptops, and high-performance computing architectures, and an HDF5-based data format is used in the backend to store and handle simulation data as well as analysis results. AMEP provides the first comprehensive framework for analyzing simulation results of both particle-based and continuum simulations (as well as experimental data) of active matter systems. In particular, AMEP also allows it to analyze simulations that combine particle-based and continuum techniques such as used to study the motion of bacteria in chemical fields or for modeling particle motion in a flow field for example.
    • Dataset
1