Filters
total: 7990
filtered: 6207
-
Catalog
- Publications 6207 available results
- Journals 67 available results
- Conferences 7 available results
- People 74 available results
- Inventions 2 available results
- Projects 2 available results
- Laboratories 1 available results
- e-Learning Courses 96 available results
- Events 6 available results
- Open Research Data 1528 available results
Chosen catalog filters
displaying 1000 best results Help
Search results for: GENERALIZED EIGENVALUE PROBLEM, FEM, COMPLEX-VALUED SPARSE MATRIX PENCIL, GPU, MAXWELL’S EQUATIONS.
-
A GPU Solver for Sparse Generalized Eigenvalue Problems with Symmetric Complex-Valued Matrices Obtained Using Higher-Order FEM
PublicationThe paper discusses a fast implementation of the stabilized locally optimal block preconditioned conjugate gradient (sLOBPCG) method, using a hierarchical multilevel preconditioner to solve nonHermitian sparse generalized eigenvalue problems with large symmetric complex-valued matrices obtained using the higher-order finite-element method (FEM), applied to the analysis of a microwave resonator. The resonant frequencies of the low-order...
-
A memory efficient and fast sparse matrix vector product on a Gpu
PublicationThis paper proposes a new sparse matrix storage format which allows an efficient implementation of a sparse matrix vector product on a Fermi Graphics Processing Unit (GPU). Unlike previous formats it has both low memory footprint and good throughput. The new format, which we call Sliced ELLR-T has been designed specifically for accelerating the iterative solution of a large sparse and complex-valued system of linear equations arising...
-
Block Conjugate Gradient Method with Multilevel Preconditioning and GPU Acceleration for FEM Problems in Electromagnetics
PublicationIn this paper a GPU-accelerated block conjugate gradient solver with multilevel preconditioning is presented for solving large system of sparse equations with multiple right hand-sides (RHSs) which arise in the finite-element analysis of electromagnetic problems. We demonstrate that blocking reduces the time to solution significantly and allows for better utilization of the computing power of GPUs, especially when the system matrix...
-
Single and Dual-GPU Generalized Sparse Eigenvalue Solvers for Finding a Few Low-Order Resonances of a Microwave Cavity Using the Finite-Element Method
PublicationThis paper presents two fast generalized eigenvalue solvers for sparse symmetric matrices that arise when electromagnetic cavity resonances are investigated using the higher-order finite element method (FEM). To find a few loworder resonances, the locally optimal block preconditioned conjugate gradient (LOBPCG) algorithm with null-space deflation is applied. The computations are expedited by using one or two graphical processing...
-
Tuning matrix-vector multiplication on GPU
PublicationA matrix times vector multiplication (matvec) is a cornerstone operation in iterative methods of solving large sparse systems of equations such as the conjugate gradients method (cg), the minimal residual method (minres), the generalized residual method (gmres) and exerts an influence on overall performance of those methods. An implementation of matvec is particularly demanding when one executes computations on a GPU (Graphics...
-
GPU-accelerated finite element method
PublicationIn this paper the results of the acceleration of computations involved in analysing electromagnetic problems by means of the finite element method (FEM), obtained with graphics processors (GPU), are presented. A 4.7-fold acceleration was achieved thanks to the massive parallelization of the most time-consuming steps of FEM, namely finite-element matrix-generation and the solution of a sparse system of linear equations with the...
-
Preconditioners with Low Memory Requirements for Higher-Order Finite-Element Method Applied to Solving Maxwell’s Equations on Multicore CPUs and GPUs
PublicationThis paper discusses two fast implementations of the conjugate gradient iterative method using a hierarchical multilevel preconditioner to solve the complex-valued, sparse systems obtained using the higher order finite-element method applied to the solution of the time-harmonic Maxwell equations. In the first implementation, denoted PCG-V, a classical V-cycle is applied and the system of equations on the lowest level is solved...
-
Tuning a Hybrid GPU-CPU V-Cycle Multilevel Preconditioner for Solving Large Real and Complex Systems of FEM Equations
PublicationThis letter presents techniques for tuning an accelerated preconditioned conjugate gradient solver with a multilevel preconditioner. The solver is optimized for a fast solution of sparse systems of equations arising in computational electromagnetics in a finite element method using higher-order elements. The goal of the tuning is to increase the throughput while at the same time reducing the memory requirements in order to allow...
-
A Task-Scheduling Approach for Efficient Sparse Symmetric Matrix-Vector Multiplication on a GPU
PublicationIn this paper, a task-scheduling approach to efficiently calculating sparse symmetric matrix-vector products and designed to run on Graphics Processing Units (GPUs) is presented. The main premise is that, for many sparse symmetric matrices occurring in common applications, it is possible to obtain significant reductions in memory usage and improvements in performance when the matrix is prepared in certain ways prior to computation....
-
Implementation of algebraic procedures on the GPU using CUDA architecture on the example of generalized eigenvalue problem
Publication -
Finite element matrix generation on a GPU
PublicationThis paper presents an efficient technique for fast generation of sparse systems of linear equations arising in computational electromagnetics in a finite element method using higher order elements. The proposed approach employs a graphics processing unit (GPU) for both numerical integration and matrix assembly. The performance results obtained on a test platform consisting of a Fermi GPU (1x Tesla C2075) and a CPU (2x twelve-core...
-
GPU-Accelerated LOBPCG Method with Inexact Null-Space Filtering for Solving Generalized Eigenvalue Problems in Computational Electromagnetics Analysis with Higher-Order FEM
PublicationThis paper presents a GPU-accelerated implementation of the Locally Optimal Block Preconditioned Conjugate Gradient (LOBPCG) method with an inexact nullspace filtering approach to find eigenvalues in electromagnetics analysis with higherorder FEM. The performance of the proposed approach is verified using the Kepler (Tesla K40c) graphics accelerator, and is compared to the performance of the implementation based on functions from...
-
GENERAL DYNAMIC PROJECTING OF MAXWELL EQUATIONS
PublicationA complete – system of Maxwell equations is splitting into independent subsystems by means of a special dynamic projecting technique. The technique relies upon a direct link between field components that determine correspondent subspaces. The explicit form of links and corresponding subspace evolution equations are obtained in conditions of certain symmetry, it is illustrated by examples of spherical and quasi-one-dimensional waves.
-
Accuracy, Memory and Speed Strategies in GPU-based Finite-Element Matrix-Generation
PublicationThis paper presents strategies on how to optimize GPU-based finite-element matrix-generation that occurs in the finite-element method (FEM) using higher order curvilinear elements. The goal of the optimization is to increase the speed of evaluation and assembly of large finite-element matrices on a single GPU (Graphics Processing Unit) while maintaining the accuracy of numerical integration at the desired level. For this reason,...
-
Jacobi and gauss-seidel preconditioned complex conjugate gradient method with GPU acceleration for finite element method
PublicationIn this paper two implementations of iterative solvers for solving complex symmetric and sparse systems resulting from finite element method applied to wave equation are discussed. The problem under investigation is a dielectric resonator antenna (DRA) discretized by FEM with vector elements of the second order (LT/QN). The solvers use the preconditioned conjugate gradient (pcg) method implemented on Graphics Processing Unit (GPU)...
-
On tracking properties of real-valued generalized adaptive notch filters
PublicationGeneralized adaptive notch filters (GANFs) are used for identification/tracking of quasi-periodically varying dynamic systems and can be considered an extension, to the system case, of classical adaptive notch filters. The paper presents results of local performance analysis of a real-valued GANF algorithm, i.e., algorithm designed to track parameters of a real-valued system. This is an extension of the previous work which focused...
-
GPU-Accelerated Finite-Element Matrix Generation for Lossless, Lossy, and Tensor Media [EM Programmer's Notebook]
PublicationThis paper presents an optimization approach for limiting memory requirements and enhancing the performance of GPU-accelerated finite-element matrix generation applied in the implementation of the higher-order finite-element method (FEM). It emphasizes the details of the implementation of the matrix-generation algorithm for the simulation of electromagnetic wave propagation in lossless, lossy, and tensor media. Moreover, the impact...
-
Generalized adaptive notch smoothers for real-valued signals and systems
PublicationSystems with quasi-periodically varying coefficients can be tracked using the algorithms known as generalized adaptive notch filters (GANFs). GANF algorithms can be considered an extension, to the system case, of classical adaptive notch filters (ANFs). We show that estimation accuracy of the existing algorithms, as well as their robustness to the choice of design parameters, can be considerably improved by means of compensating...
-
Analysis of nonlinear eigenvalue problems for guides and resonators in microwave and terahertz technology
PublicationThis dissertation presents developed numerical tools for investigating waveguides and resonators' properties for microwave and terahertz technology. The electromagnetics analysis requires solving complex eigenvalue problems, representing various parameters such as resonant frequency or propagation coefficient. Solving equations with eigenvalue boils down to finding the roots of the determinant of the matrix. At the beginning, one...
-
Anisotropic Orlicz–Sobolev spaces of vector valued functions and Lagrange equations
PublicationIn this paper we study some properties of anisotropic Orlicz and Orlicz–Sobolev spaces of vector valued functions for a special class of G-functions. We introduce a variational setting for a class of Lagrangian Systems. We give conditions which ensure that the principal part of variational functional is finitely defined and continuously differentiable on Orlicz–Sobolev space.
-
Quasi-solutions for generalized second order differential equations with deviating arguments
PublicationThis paper deal with boundary value problems for generalized second order differential equations with deviating arguments. Existence of quasi-solutions and solutions are proved by monotone iterative method. Examples with numerical results are added.
-
Communication and Load Balancing Optimization for Finite Element Electromagnetic Simulations Using Multi-GPU Workstation
PublicationThis paper considers a method for accelerating finite-element simulations of electromagnetic problems on a workstation using graphics processing units (GPUs). The focus is on finite-element formulations using higher order elements and tetrahedral meshes that lead to sparse matrices too large to be dealt with on a typical workstation using direct methods. We discuss the problem of rapid matrix generation and assembly, as well as...
-
Multimodal Genetic Algorithm with Phase Analysis to Solve Complex Equations of Electromagnetic Analysis
PublicationIn this contribution, a new genetic-algorithm-based method of finding roots and poles of a complex function of a complex variable is presented. The algorithm employs the phase analysis of the function to explore the complex plane with the use of the genetic algorithm. Hence, the candidate regions of root and pole occurrences are selected and verified with the use of discrete Cauchy's argument principle. The algorithm is evaluated...
-
Estimation and tracking of complex-valued quasi-periodically varying systems
PublicationW artykule rozważany jest problem identyfikacji obiektów o parametrach zmieniających się w sposób pseudookresowy. Przedstawiono w nim algorytm oparty o metodę funkcji bazowych umożliwiający śledzenie takich obiektów oraz pokazano atrakcyjne z punktu widzenia złożoności obliczeń jego wersje zdekomponowane. Przydatność rozważanych algorytmów uzasadniono porównując je z rozwiązaniami innych autorów.
-
Inverse Nonlinear Eigenvalue Problem Framework for the Synthesis of Coupled-Resonator Filters With Nonresonant Nodes and Arbitrary Frequency-Variant Reactive Couplings
PublicationA novel, general circuit-level description of coupledresonator microwave filters is introduced in this article. Unlike well-established coupling-matrix models based on frequency-invariant couplings or linear frequency-variant couplings (LFVCs), a model with arbitrary reactive frequencyvariant coupling (AFVC) networks is proposed. The engineered formulation is more general than prior-art ones—with the only restriction that the coupling...
-
Green's function for the wavized Maxwell fish-eye problem
PublicationRozpatrzono niezależne od czasu skalarne równanie falowe dla ośrodka typu ''rybie oko'' Maxwella w przestrzeni R^N (N >=2). Pokazano, że równanie to posiada unikalne własności transformacyjne względem inwersji w pewnej klasie hipersfer. Wykorzystano ten fakt do znalezienia zamkniętej postaci funkcji Greena, oraz uogólnionej funkcji Greena, dla wyjściowego równania.
-
DEM-FEM model of highly saturated soil motion due to seepage force
PublicationArtykuł poświęcono nowej propozycji rozwiązania problemu modelowania zjawiska transportu, które występuje wewnątrz wysoko-nawodnionego gruntu ziarnistego na skutek ciśnienia spływowego. Teoria oparta została na połączeniu metody elementów skończonych (FEM - Finite Element Method) - rozwiązania równań poro-elastycznych oraz metody poszczególnych elementów (DEM - Distinct Element Method), które dały podwójny model numeryczny. FEM...
-
GPU-Accelerated 3D Mesh Deformation for Optimization Based on the Finite Element Method
PublicationThis paper discusses a strategy for speeding up the mesh deformation process in the design-byoptimization of high-frequency components involving electromagnetic field simulations using the 3D finite element method (FEM). The mesh deformation is assumed to be described by a linear elasticity model of a rigid body; therefore, each time the shape of the device is changed, an auxiliary elasticity finite-element problem must be solved....
-
A Novel Coupling Matrix Synthesis Technique for Generalized Chebyshev Filters With Resonant Source–Load Connection
PublicationThis paper reports a novel synthesis method for microwave bandpass filters with resonant source–load connection. In effect, a network realizing N+1 transmission zeros (where N is the number of reflection zeros) is obtained. The method is based on a prototype transversal coupling matrix (N+2, N+2) with source and load connected by a resonant circuit formed by a capacitor in parallel with a frequency-invariant susceptance. To complement...
-
Efficiency of acoustic heating in the Maxwell fluid
PublicationThe nonlinear effects of sound in a fluid describing by the Maxwell model of the viscous stress tensor is the subject of investigation. Among other, viscoelastic biological media belong to this non-newtonian type of fluids. Generation of heating of the medium caused by nonlinear transfer of acoustic energy, is discussed in details. The governing equation of acoustic heating is derived by means of the special linear combination...
-
Efficiency of acoustic heating in the Maxwell fluid
PublicationThe nonlinear effects of sound in a fluid describing by the Maxwell model of the viscous stress tensor is the subject of investigation. Among other, viscoelastic biological media belong to this non-newtonian type of fluids. Generation of heating of the medium caused by nonlinear transfer of acoustic energy, is discussed in details. The governing equation of acoustic heating is derived by means of the special linear combination...
-
Solution of coupled integral equations for quantum scattering in the presence of complex potentials
PublicationIn this paper, we present a method to compute solutions of coupled integral equations for quantum scattering problems in the presence of a complex potential. We show how the elastic and absorption cross sections can be obtained from the numerical solution of these equations in the asymptotic region at large radial distances.
-
Performance evaluation of parallel background subtraction on GPU platforms
PublicationImplementation of the background subtraction algorithm on parallel GPUs is presented. The algorithm processes video streams and extracts foreground pixels. The work focuses on optimizing parallel algorithm implementation by taking into account specific features of the GPU architecture, such as memory access, data transfers and work group organization. The algorithm is implemented in both OpenCL and CUDA. Various optimizations of...
-
Modal FEM Analysis of Ferrite Resonant Structures
PublicationThe finite-element method (FEM) is applied for modal analysis of ferrite-loaded spherical resonators. To improve the efficiency of the numerical calculations, the body-of-revolution (BOR) technique is utilized. Due to the frequency-dependent ferrite permeability, FEM leads to a nonlinear eigenvalue problem that is challenging to solve. To this end, Beyn’s method is proposed. The effectiveness of the proposed approach is confirmed...
-
The maximum edge-disjoint paths problem in complete graphs
PublicationRozważono problem ścieżek krawędziowo rozłącznych w grafach pełnych. Zaproponowano wielomianowe algorytmy: 3.75-przybliżony (off-line) oraz 6.47-przybliżony (on-line), poprawiając tym samym wyniki wcześniej znane z literatury [P. Carmi, T. Erlebach, Y. Okamoto, Greedy edge-disjoint paths in complete graphs, in: Proc. 29th Workshop on Graph Theoretic Concepts in Computer Science, in: LNCS, vol. 2880, 2003, pp. 143-155]. Ponadto...
-
Main complications connected with detection, identification and determination of trace organic constituents in complex matrix samples
PublicationIt is well known that some problems with the determination of organic analytes at trace level can occur. This issue is connected with contamination during each stage of the analytical procedure from sampling to sample preparation up to chromatographic analysis, which often leads to false-positive or overestimated results. Another problem associated with determination of analytes occurs at trace- and ultra-trace level is a background...
-
Investigation of Vibro-Acoustical Properties Using Eigenvalue Problem Solution and Wavelets
Publication -
Systems of differential equations with a singular matrix
PublicationPraca dotyczy układów równań różniczkowych z macierzą osobliwą. Szczególnymi przypadkami takich układów są równania różniczkowo-algebraiczne. Korzystając z odpowiedniej nierówności różniczkowej dla układów równań i metody quasi linearyzacji pokazano, iż odpowiednie monotoniczne ciągi są zbieżne do rozwiązania naszego problemu i jest to zbieżność kwadratowa. O funkcji f występującej po prawej stronie zagadnienia zakładano...
-
Comparison of Optimization Techniques for Coupling Matrix Synthesis Using Eigenvalue Based Approach
Publication -
Multilevel model order reduction with generalized compression of boundaries for 3-d FEM electromagnetic analysis
PublicationThis paper presents a multilevel Model Order Reduction technique for a 3-D electromagnetic Finite Element Method analysis. The reduction process is carried out in a hierarchical way and involves several steps which are repeated at each level. This approach brings about versatility and allows one to efficiently analyze complex electromagnetic structures. In the proposed multilevel reduction the entire computational domain is covered...
-
Vortex flow caused by periodic and aperiodic sound in a relaxing maxwell fluid
PublicationThis paper concerns the description of vortex flow generated by periodic and aperiodic sound in relaxing Maxwell fluid. The analysis is based on governing equation of vorticity mode, which is a result of decomposition of the hydrodynamic equations for fluid flow with relaxation and thermal conductivity into acoustical and non-acoustical parts. The equation governing vorticity mode uses only instantaneous, not averaged over sound...
-
General quasilinearization method for systems of differential equations with a singular matrix
PublicationStosując metodę kwazilinearyzacji badano problem rozwiązań przybliżonych dla układów równań różniczkowych z macierzą osobliwą. Pokazano zbieżność kwadratową odpowiednich ciągów monotonicznych.
-
Generalized quazilinearization for systems of degenerate singular perturbation problem
PublicationPraca dotyczy ogólnej metody kwazilinearyzacji dla układów równań różniczkowych z parametrami.
-
Sparse autoregressive modeling
PublicationIn the paper the comparison of the popular pitch determination (PD) algorithms for thepurpose of elimination of clicks from archive audio signals using sparse autoregressive (SAR)modeling is presented. The SAR signal representation has been widely used in code-excitedlinear prediction (CELP) systems. The appropriate construction of the SAR model is requiredto guarantee model stability. For this reason the signal representation...
-
On the Chaplyghin method for generalized solutions of partial differential functional equations
PublicationW pracy tej rozważa się zagadnienia początkowo-brzegowe dla semiliniowych równań różniczkowo-funkcyjnych cząstkowych pierwszego rzędu. Przy naturalnych założeniach o funkcjach danych, istnieje ciąg Czapłygina i jest on zbieżny do rozwiązania w sensie Caratheodory'ego wyjściowego zagadnienia. Podane jest oszacowanie błędu rozwiązania przybliżonego. Wykazuje się, iż metoda Czapłygina dla powyższego zagadnienia jest równoważna metodzie...
-
Differential equations with a singular matrix and convergence of approximate solutions
PublicationZastosowano metodę kwazilinearyzacji dla równań różniczkowych z macierzą osobliwą aby pokazać, że odpowiednie ciągi rozwiązań przybliżonych są kwadratowo zbieżne do rozwiązania naszego problemu.Metodę tę zastosowano do układów takich równań różniczkowych.
-
Degree of entaglement as a physically ill-posted problem: The case of entaglement with vacuum
PublicationAnalizujemy przypadek fotonu w superpozycji różnych modów i zadajemy pytanie o stopień ich splątania z próżnią. Problem okazuje się być źle postawiony, gdyż nie wiemy którą reprezentację algebry CCR wybrać dla kwantowania pola. Gdy dokonamy wyboru jednoznacznie możemy rozwiązać zagadnienie splątania. Tak więc trudność nie leży w matematyce lecz w fizyce problemu.
-
Macromodels for efficient FEM simulations of waveguides and resonators
PublicationThis paper introduces a novel technique for enhancing the efficiency of the finite element method (FEM) by incorporating special modules, called macromodels, into the standard eigenvalue formulation. The number of unknowns in the separated macromodel subdomain can be significantly reduced by orthogonal projection, using the efficient nodal order reduction algorithm. The idea of macromodels implementation is demonstrated on a simple...
-
Dynamic GPU power capping with online performance tracing for energy efficient GPU computing using DEPO tool
PublicationGPU accelerators have become essential to the recent advance in computational power of high- performance computing (HPC) systems. Current HPC systems’ reaching an approximately 20–30 mega-watt power demand has resulted in increasing CO2 emissions, energy costs and necessitate increasingly complex cooling systems. This is a very real challenge. To address this, new mechanisms of software power control could be employed. In this...
-
The generalized quasilinearization for integro-differential equations of Volterra type on time scales
PublicationBadano równania całkowo-różniczkowe on ''time scales'' i podano warunkidostateczne na zbieżność metody kwazilinearyzacji do jego rozwiązania. Podano warunki na to, aby zbieżność ta była kwadratową.