Abstract
The paper introduces a new approach to kriging based multi-objective optimization by utilizing a local probability of improvement as the infill sampling criterion and the nearest neighbor check to ensure diversification and uniform distribution of Pareto fronts. The proposed method is computationally fast and linearly scalable to higher dimensions.
1 Introduction
Research on multiple objective optimization (MO) has been attracting significant attention of the engineering community since 1980s; with the aid of fast computers solutions to many complex optimization problems have been made possible. The Vector Evaluated Genetic Algorithm (VEGA) [1] is one of the earliest examples of Multi-Objective Evolutionary Algorithms (MOEAs). The more recent developments include NSGA-II [2] and its modified versions as well as Particle Swarm based methods [3]. A comprehensive review of problem definitions and non-EA based solution methods may be found in [4].
There is an increasing number of indicator-based MOEAs that have been proposed in recent years; the indicator is used as a fitness measure for a set of Pareto points, and – by optimizing the indicator function – the MO problem essentially becomes a single objective optimization problem as the solver only needs to locate the optimal value of the indicator value and update the generation based on it. One of the best-known indicators is the hypervolume [5]; it has been successfully applied to both EAs and surrogate-based algorithms. Despite its unique feature of being strictly monotonic to Pareto improvements [6], it suffers from high computational cost for higher dimensions.
The general opinion favors EAs as advantageous in solving MO problems by often being population based, thus multiple solutions can be obtained in a single run. However, solutions to practical problems may be expensive in terms of computational time and effort. In the context of electromagnetic devices, the finite element method is a common design tool; it often takes hours or even days to obtain a single solution, therefore surrogate model based algorithms are often preferred.
In this study we propose a new indicator focused Localized Probability of Improvement (LPoI) approach for MO problems; its implementation requires the predicted mean and mean square errors to be available, hence it is not applicable to other EAs, but for Gaussian based surrogate models (including those relying on kriging) it has the advantage of being linearly scalable to problems with higher number of objectives.
2 Kriging theory
Modern engineering design often involves implementation of deterministic computer simulation; in electromagnetic design, time consuming finite element models (FEM) are often built to represent the actual devices. Designs are analyzed and optimized before being put into production. In these types of problems, the optimization can be a very time consuming process due to a large number of FEM calls needed. Therefore surrogate modeling techniques are often used to reduce the number of expensive FEM simulations.
Kriging is one of the most commonly used surrogate techniques amongst many others. An ordinary kriging model Y consists of a global mean f and a local departure Z:
where x is the location of any design site.
The local departure follows the Gaussian distribution with a mean of zero, variance σ2 and non-zero covariance. A general exponential correlation function is one of the most commonly used correlation functions, due to its continuous characteristic and flexibility
where xi and xj are a pair of observations, k is the problem dimension, while θn and pn are hyperparameters controlling the shape of the correlation function.
Kriging parameters u, σ2 and the hyperparameters θ and p are obtained via the Maximum Likelihood Estimation (MLE), with the maximum likelihood function given by
where y denotes all observations and R is the correlation matrix.
The kriging prediction and the predicted mean square error (MSE) at a given location x are given as follows
with
3 Localized probability of improvement
Compared to other surrogate modeling methods, kriging has the advantage of providing both the predicted mean and the associated mean square error (MSE) at an unknown location. The probability of improvement PoI at any location is given by
where yt is the target of improvement, ŷ the kriging predicted mean at location x, ŝ is a square root of the mean square error at location x and Φ(⋅) is the cumulative distribution function.
The first improvement target yext is associated with the minimum value of each individual objective function; the subscript ext stands for “extreme value” and yext is given by
where yminn is the known minimum value of the nth objective function and p is the percentage of improvement to be defined; parameter p is discussed later in this section. The corresponding PoI is:
where ŷn, ŝn, yextn and PoIextn are the corresponding measures of the nth objective function.
For the first improvement target, we find n values of PoI, which equals to the number of objectives, because the PoIext is calculated based on the extreme value of each objective function. We consider the maximum potential improvement for all individual objectives, hence
The second improvement target yintn (x) is associated withthe reference point that is defined based on the location of x. The subscript int stands for “intermediate” and yref is calculated as
where yref is the calculated reference point.
To obtain the reference point yref, the algorithm finds the Pareto front for the existing design sites using non-dominated sorting. For each closest set of Pareto points (the number of points is equal to the number of objectives) it calculates the corresponding reference point. The coordinates for the reference point of each dimension is equal to the maximum value of the coordinates for these Pareto points in the same dimension. The coordinates for the corresponding reference point in the nth dimension Ref (xn) is given by:
where Yn is the collection of the nth objective values for all of the points in that Pareto set.
Taking a bi-objective problem as an example, assuming the reference point yref is to be determined for Pareto points P1 and P2, the coordinates of P1 and P2 are therefore denoted by [P1.x1, P1.x2] and [P2.x1, P2.x2], respectively. Note that xn is the nth objective value at the location in the search space associated with P. The x1 and x2 coordinates (in the objective space) of the reference point are thus described as follows
and the corresponding PoI is given as
where yrefn, ŷn, ŝn, PoIrefn and PoIextn are the corresponding measures of the nth objective function.
We have therefore obtained n values of PoI for the second improvement target. However, unlike the first improvement target, the second one uses a localized target. Therefore, we consider using the minimum potential improvement for all individual objectives and hence
Finally, the proposed indicator LPoI for any given point is the maximum of these two probability of improvement measures, given by
where PoIext, as described by (9), is due to the fact that the minimum of each individual objective function is always present in the Pareto front, thus the PoI at each location x, over the optimal target of that function, is always considered. This term also contributes to the diversification of the Pareto front.
Furthermore, LPoIref – as described by (15) – can be treated as a maximum of the minimum potential improvements to a local target. This term helps to improve the Pareto front both towards the origin and in the direction of the objective value. It contributes to the diversification of the Pareto front, while the max-min method also contributes to the uniformity of the Pareto front.
To obtain the next infill sampling point, the algorithm finds the location x associated with the maximum LPoI measure in the objective space.
The parameter p – as seen in (7) and (10) – is associated with the magnitude of target improvement; it controls the convergence rate of the algorithm. A smaller amount of improvement will guide the solver towards existing Pareto points, while a larger value will encourage the exploration of the design space. It is crucial to use a proper p, since too small a value may lead to a false Pareto front, while a large value may result in a slow convergence rate or zero probability of improvement at all unknown sites. Thus it is advisable to dynamically adjust the value while monitoring the convergence.
We provide a simple self-adjusted method for parameter p in this paper. First, the initial improvement target percentage pinitial is defined and then the parameter p is calculated as
where LPoIprev is a complete set of LPoI at previous iteration.
The next infill point is taken at the location with a maximum LPoI. Therefore, the solver tends to minimise the localised probability of improvement and converges towards the Pareto front. When the design space is well explored, or p is especially small, the solver will converge towards existing Pareto fronts; at this stage, it is common for the LPoI to be equal, or come close, to 1 at multiple unknown sites (extremely likely to improve over the target point). In order to obtain a uniformly distributed Pareto front, the algorithm selects candidates which have the largest Euclidean distance to existing Pareto points compared to the next infill sampling points. For this reason, the maximum value of LPoI can be capped between 0.9 and 1 for faster exploitation of the existing Pareto front without degrading the overall performance.
4 Test examples
The top graph in Figure 1 shows the kriging model (solid line) after 45 iterations, with the red crosses plotted at the true Pareto ront, while the bottom plot shows the proposed indicator value for the unknown sites. As can be seen, the algorithm has correctly converged to all four Pareto point clusters in the search space and thus further sampling will lead to more exploitation on the Pareto front. The sampled design sites in the objective space are plotted in Figure 2, where the red dots indicate the location of the true Pareto front. The improvement direction imposed by the two improvement targets are illustrated in Figure 2, where the yellow arrows show the improvement direction for the first improvement target, and the blue arrows indicate the improvement direction for the second improvement target.

The kriging model and the LPoI criterion in the search space

Existing design sites in the criterion space after 20 iterations

Existing design sites in the criterion space after 45 iterations
5 Solving the new TEAM problem
A new TEAM problem was proposed at the Compumag conference in Korea, June 2017 [7]. This is devoted specifically to multi-objective optimization. In its extended version, an additional objective has been added and there are therefore in total three objectives. The model consists of an air-cored multi-turn winding. By arranging the current-carrying coils, a desired magnetic field distribution is to be obtained. The flux density at point z is given by
The problem is specified as follows: given the current density J within the coil, and prescribed flux density, find the optimal r distribution of radii r(z), —d ≤ z ≤ d that yields the prescribed flux density B0(z).
An initial arrangement of turns was given in the extended paper of [7], the width of each turn w and the height h are 1 mm and 1.5m m, respectively.

Example of radii distribution; geometry and magnetic flux lines
The model consists of 20 turns connected in series, symmetrically distributed, hence there are 10 radii which need to be optimized (the main objective f1). Two additional objectives were proposed to complement the first objective f1. The three objectives f1, f2 and f3 may be described as follows:
f1: find the optimal distribution of r, so that the discrepancy between the prescribed flux density B0 and the actual induction field B is minimized;
f2: minimize the sensitivity function;
f3: minimize the power loss related function.
Mathematically the three objective functions are expressed as
where B+ = B (r (ξl + Δξ), zq), B— = B (r (ξl — Δξ),zq), l = 1, nt and q = 1, np. Δξ = 0.5 mm. At this stage it was suggested to consider only two objectives at the time, f1 and either f2 or f3.
The optimization results are illustrated by Figs. 5 and 6, where objectives 2 and 3 are plotted against objective 1, respectively. The globally optimal points A and B (defined by the closeness to the respective utopia points) are defined by the radii distributions [11.4, 8.6, 9.1, 12.1, 8.9, 8.3, 7.0, 6.4, 6.8, 5.9] and [7.2, 10.6, 7.2, 6.6, 9.0, 5.2, 9.2, 5.0, 5.4, 6.9], respectively.

Pareto front of f1 and f2 in the objective space

Pareto front of f1 and f3 in the objective space
6 Conclusion
A novel approach to kriging-based multi objective optimization is put forward relying on the Localized Probability of Improvement. For illustration purposes a bi-objective test problem is provided, as well as the recently introduced TEAM benchmark problem. It is shown that the proposed method addresses efficiently both the diversification and uniformity of the Pareto solution, is computationally efficient and is linearly scalable to higher number of objectives.
References
[1] Schaffer J.D., Multiple objective optimization with vector evaluated genetic algorithms, Proceedings of the 1st International Conference on Genetic Algorithms, 1985, 93-100Search in Google Scholar
[2] Deb K., Agrawal S., Pratap A., Meyarivan T., A fast elitist non-dominated sorting genetic algorithm for multi-objective optimization: NSGA-II, in Schoenauer M. et al. (eds), Parallel Problem Solving from Nature PPSN VI, 200010.1007/3-540-45356-3Search in Google Scholar
[3] Parsopoulos K.E., Vrahatis M.N., Particle swarm optimization method in multiobjective problems, SAC’02 Proceedings of the 2002 ACM Symposium on Applied Computing, 2002, 603-60710.1145/508791.508907Search in Google Scholar
[4] Marler R.T., Arora J. S., Survey of multi-objective optimization methods for engineering, Structural and Multidisciplinary Optimization, 2004, 26, 6, 36910.1007/s00158-003-0368-6Search in Google Scholar
[5] Zitzler E., Thiele L., Multiobjective evolutionary algorithms: a comparative case study and the strength Pareto approach, IEEE Transactions on Evolutionary Computation, 1999, 3, 4, 257-27110.1109/4235.797969Search in Google Scholar
[6] Knowles J., Corne D., On metrics for comparing nondominated sets, Evolutionary Computation, Proceedings of CEC’02, Honolulu, 2002, 711-71610.1109/CEC.2002.1007013Search in Google Scholar
[7] Barba P.D., Mognaschi M.E., Song X., Lowther D.A., Sykulski J.K., A benchmark TEAM problem for multiobjective Pareto optimization of electromagnetic devices, IEEE Transactions on Magnetics, 2017, PP, 99Search in Google Scholar
© 2017 Yinjiang Li et al.
This work is licensed under the Creative Commons Attribution-NonCommercial-NoDerivatives 4.0 License.
Articles in the same Issue
- Regular Articles
- Analysis of a New Fractional Model for Damped Bergers’ Equation
- Regular Articles
- Optimal homotopy perturbation method for nonlinear differential equations governing MHD Jeffery-Hamel flow with heat transfer problem
- Regular Articles
- Semi- analytic numerical method for solution of time-space fractional heat and wave type equations with variable coefficients
- Regular Articles
- Investigation of a curve using Frenet frame in the lightlike cone
- Regular Articles
- Construction of complex networks from time series based on the cross correlation interval
- Regular Articles
- Nonlinear Schrödinger approach to European option pricing
- Regular Articles
- A modified cubic B-spline differential quadrature method for three-dimensional non-linear diffusion equations
- Regular Articles
- A new miniaturized negative-index meta-atom for tri-band applications
- Regular Articles
- Seismic stability of the survey areas of potential sites for the deep geological repository of the spent nuclear fuel
- Regular Articles
- Distributed containment control of heterogeneous fractional-order multi-agent systems with communication delays
- Regular Articles
- Sensitivity analysis and economic optimization studies of inverted five-spot gas cycling in gas condensate reservoir
- Regular Articles
- Quantum mechanics with geometric constraints of Friedmann type
- Regular Articles
- Modeling and Simulation for an 8 kW Three-Phase Grid-Connected Photo-Voltaic Power System
- Regular Articles
- Application of the optimal homotopy asymptotic method to nonlinear Bingham fluid dampers
- Regular Articles
- Analysis of Drude model using fractional derivatives without singular kernels
- Regular Articles
- An unsteady MHD Maxwell nanofluid flow with convective boundary conditions using spectral local linearization method
- Regular Articles
- New analytical solutions for conformable fractional PDEs arising in mathematical physics by exp-function method
- Regular Articles
- Quantum mechanical calculation of electron spin
- Regular Articles
- CO2 capture by polymeric membranes composed of hyper-branched polymers with dense poly(oxyethylene) comb and poly(amidoamine)
- Regular Articles
- Chain on a cone
- Regular Articles
- Multi-task feature learning by using trace norm regularization
- Regular Articles
- Superluminal tunneling of a relativistic half-integer spin particle through a potential barrier
- Regular Articles
- Neutrosophic triplet normed space
- Regular Articles
- Lie algebraic discussion for affinity based information diffusion in social networks
- Regular Articles
- Radiation dose and cancer risk estimates in helical CT for pulmonary tuberculosis infections
- Regular Articles
- A comparison study of steady-state vibrations with single fractional-order and distributed-order derivatives
- Regular Articles
- Some new remarks on MHD Jeffery-Hamel fluid flow problem
- Regular Articles
- Numerical investigation of magnetohydrodynamic slip flow of power-law nanofluid with temperature dependent viscosity and thermal conductivity over a permeable surface
- Regular Articles
- Charge conservation in a gravitational field in the scalar ether theory
- Regular Articles
- Measurement problem and local hidden variables with entangled photons
- Regular Articles
- Compression of hyper-spectral images using an accelerated nonnegative tensor decomposition
- Regular Articles
- Fabrication and application of coaxial polyvinyl alcohol/chitosan nanofiber membranes
- Regular Articles
- Calculating degree-based topological indices of dominating David derived networks
- Regular Articles
- The structure and conductivity of polyelectrolyte based on MEH-PPV and potassium iodide (KI) for dye-sensitized solar cells
- Regular Articles
- Chiral symmetry restoration and the critical end point in QCD
- Regular Articles
- Numerical solution for fractional Bratu’s initial value problem
- Regular Articles
- Structure and optical properties of TiO2 thin films deposited by ALD method
- Regular Articles
- Quadruple multi-wavelength conversion for access network scalability based on cross-phase modulation in an SOA-MZI
- Regular Articles
- Application of ANNs approach for wave-like and heat-like equations
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Study on node importance evaluation of the high-speed passenger traffic complex network based on the Structural Hole Theory
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A mathematical/physics model to measure the role of information and communication technology in some economies: the Chinese case
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Numerical modeling of the thermoelectric cooler with a complementary equation for heat circulation in air gaps
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- On the libration collinear points in the restricted three – body problem
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Research on Critical Nodes Algorithm in Social Complex Networks
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A simulation based research on chance constrained programming in robust facility location problem
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A mathematical/physics carbon emission reduction strategy for building supply chain network based on carbon tax policy
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Mathematical analysis of the impact mechanism of information platform on agro-product supply chain and agro-product competitiveness
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A real negative selection algorithm with evolutionary preference for anomaly detection
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A privacy-preserving parallel and homomorphic encryption scheme
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Random walk-based similarity measure method for patterns in complex object
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A Mathematical Study of Accessibility and Cohesion Degree in a High-Speed Rail Station Connected to an Urban Bus Transport Network
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Design and Simulation of the Integrated Navigation System based on Extended Kalman Filter
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Oil exploration oriented multi-sensor image fusion algorithm
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Analysis of Product Distribution Strategy in Digital Publishing Industry Based on Game-Theory
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Expanded Study on the accumulation effect of tourism under the constraint of structure
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Unstructured P2P Network Load Balance Strategy Based on Multilevel Partitioning of Hypergraph
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Research on the method of information system risk state estimation based on clustering particle filter
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Demand forecasting and information platform in tourism
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Physical-chemical properties studying of molecular structures via topological index calculating
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Local kernel nonparametric discriminant analysis for adaptive extraction of complex structures
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- City traffic flow breakdown prediction based on fuzzy rough set
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Conservation laws for a strongly damped wave equation
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Blending type approximation by Stancu-Kantorovich operators based on Pólya-Eggenberger distribution
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Computing the Ediz eccentric connectivity index of discrete dynamic structures
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A discrete epidemic model for bovine Babesiosis disease and tick populations
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Study on maintaining formations during satellite formation flying based on SDRE and LQR
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Relationship between solitary pulmonary nodule lung cancer and CT image features based on gradual clustering
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A novel fast target tracking method for UAV aerial image
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Fuzzy comprehensive evaluation model of interuniversity collaborative learning based on network
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Conservation laws, classical symmetries and exact solutions of the generalized KdV-Burgers-Kuramoto equation
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- After notes on self-similarity exponent for fractal structures
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Excitation probability and effective temperature in the stationary regime of conductivity for Coulomb Glasses
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Comparisons of feature extraction algorithm based on unmanned aerial vehicle image
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Research on identification method of heavy vehicle rollover based on hidden Markov model
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Classifying BCI signals from novice users with extreme learning machine
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Topics on data transmission problem in software definition network
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Statistical inferences with jointly type-II censored samples from two Pareto distributions
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Estimation for coefficient of variation of an extension of the exponential distribution under type-II censoring scheme
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Analysis on trust influencing factors and trust model from multiple perspectives of online Auction
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Coupling of two-phase flow in fractured-vuggy reservoir with filling medium
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Production decline type curves analysis of a finite conductivity fractured well in coalbed methane reservoirs
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Flow Characteristic and Heat Transfer for Non-Newtonian Nanofluid in Rectangular Microchannels with Teardrop Dimples/Protrusions
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- The size prediction of potential inclusions embedded in the sub-surface of fused silica by damage morphology
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Research on carbonate reservoir interwell connectivity based on a modified diffusivity filter model
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- The method of the spatial locating of macroscopic throats based-on the inversion of dynamic interwell connectivity
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Unsteady mixed convection flow through a permeable stretching flat surface with partial slip effects through MHD nanofluid using spectral relaxation method
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- A volumetric ablation model of EPDM considering complex physicochemical process in porous structure of char layer
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Numerical simulation on ferrofluid flow in fractured porous media based on discrete-fracture model
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Macroscopic lattice Boltzmann model for heat and moisture transfer process with phase transformation in unsaturated porous media during freezing process
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Modelling of intermittent microwave convective drying: parameter sensitivity
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Simulating gas-water relative permeabilities for nanoscale porous media with interfacial effects
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Simulation of counter-current imbibition in water-wet fractured reservoirs based on discrete-fracture model
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Investigation effect of wettability and heterogeneity in water flooding and on microscopic residual oil distribution in tight sandstone cores with NMR technique
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Analytical modeling of coupled flow and geomechanics for vertical fractured well in tight gas reservoirs
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Special Issue: Ever New "Loopholes" in Bell’s Argument and Experimental Tests
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- The ultimate loophole in Bell’s theorem: The inequality is identically satisfied by data sets composed of ±1′s assuming merely that they exist
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Erratum to: The ultimate loophole in Bell’s theorem: The inequality is identically satisfied by data sets composed of ±1′s assuming merely that they exist
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Rhetoric, logic, and experiment in the quantum nonlocality debate
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- What If Quantum Theory Violates All Mathematics?
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Relativity, anomalies and objectivity loophole in recent tests of local realism
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- The photon identification loophole in EPRB experiments: computer models with single-wing selection
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Bohr against Bell: complementarity versus nonlocality
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Is Einsteinian no-signalling violated in Bell tests?
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Bell’s “Theorem”: loopholes vs. conceptual flaws
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Nonrecurrence and Bell-like inequalities
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Three-dimensional computer models of electrospinning systems
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Electric field computation and measurements in the electroporation of inhomogeneous samples
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Modelling of magnetostriction of transformer magnetic core for vibration analysis
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Comparison of the fractional power motor with cores made of various magnetic materials
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Dynamics of the line-start reluctance motor with rotor made of SMC material
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Inhomogeneous dielectrics: conformal mapping and finite-element models
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Topology optimization of induction heating model using sequential linear programming based on move limit with adaptive relaxation
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Detection of inter-turn short-circuit at start-up of induction machine based on torque analysis
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Current superimposition variable flux reluctance motor with 8 salient poles
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Modelling axial vibration in windings of power transformers
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Field analysis & eddy current losses calculation in five-phase tubular actuator
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Hybrid excited claw pole generator with skewed and non-skewed permanent magnets
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Electromagnetic phenomena analysis in brushless DC motor with speed control using PWM method
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Field-circuit analysis and measurements of a single-phase self-excited induction generator
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- A comparative analysis between classical and modified approach of description of the electrical machine windings by means of T0 method
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Field-based optimal-design of an electric motor: a new sensitivity formulation
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Application of the parametric proper generalized decomposition to the frequency-dependent calculation of the impedance of an AC line with rectangular conductors
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Virtual reality as a new trend in mechanical and electrical engineering education
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Holonomicity analysis of electromechanical systems
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- An accurate reactive power control study in virtual flux droop control
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Localized probability of improvement for kriging based multi-objective optimization
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Research of influence of open-winding faults on properties of brushless permanent magnets motor
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Optimal design of the rotor geometry of line-start permanent magnet synchronous motor using the bat algorithm
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Model of depositing layer on cylindrical surface produced by induction-assisted laser cladding process
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Detection of inter-turn faults in transformer winding using the capacitor discharge method
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- A novel hybrid genetic algorithm for optimal design of IPM machines for electric vehicle
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Lamination effects on a 3D model of the magnetic core of power transformers
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Detection of vertical disparity in three-dimensional visualizations
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Calculations of magnetic field in dynamo sheets taking into account their texture
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- 3-dimensional computer model of electrospinning multicapillary unit used for electrostatic field analysis
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Optimization of wearable microwave antenna with simplified electromagnetic model of the human body
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Induction heating process of ferromagnetic filled carbon nanotubes based on 3-D model
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Speed control of an induction motor by 6-switched 3-level inverter
Articles in the same Issue
- Regular Articles
- Analysis of a New Fractional Model for Damped Bergers’ Equation
- Regular Articles
- Optimal homotopy perturbation method for nonlinear differential equations governing MHD Jeffery-Hamel flow with heat transfer problem
- Regular Articles
- Semi- analytic numerical method for solution of time-space fractional heat and wave type equations with variable coefficients
- Regular Articles
- Investigation of a curve using Frenet frame in the lightlike cone
- Regular Articles
- Construction of complex networks from time series based on the cross correlation interval
- Regular Articles
- Nonlinear Schrödinger approach to European option pricing
- Regular Articles
- A modified cubic B-spline differential quadrature method for three-dimensional non-linear diffusion equations
- Regular Articles
- A new miniaturized negative-index meta-atom for tri-band applications
- Regular Articles
- Seismic stability of the survey areas of potential sites for the deep geological repository of the spent nuclear fuel
- Regular Articles
- Distributed containment control of heterogeneous fractional-order multi-agent systems with communication delays
- Regular Articles
- Sensitivity analysis and economic optimization studies of inverted five-spot gas cycling in gas condensate reservoir
- Regular Articles
- Quantum mechanics with geometric constraints of Friedmann type
- Regular Articles
- Modeling and Simulation for an 8 kW Three-Phase Grid-Connected Photo-Voltaic Power System
- Regular Articles
- Application of the optimal homotopy asymptotic method to nonlinear Bingham fluid dampers
- Regular Articles
- Analysis of Drude model using fractional derivatives without singular kernels
- Regular Articles
- An unsteady MHD Maxwell nanofluid flow with convective boundary conditions using spectral local linearization method
- Regular Articles
- New analytical solutions for conformable fractional PDEs arising in mathematical physics by exp-function method
- Regular Articles
- Quantum mechanical calculation of electron spin
- Regular Articles
- CO2 capture by polymeric membranes composed of hyper-branched polymers with dense poly(oxyethylene) comb and poly(amidoamine)
- Regular Articles
- Chain on a cone
- Regular Articles
- Multi-task feature learning by using trace norm regularization
- Regular Articles
- Superluminal tunneling of a relativistic half-integer spin particle through a potential barrier
- Regular Articles
- Neutrosophic triplet normed space
- Regular Articles
- Lie algebraic discussion for affinity based information diffusion in social networks
- Regular Articles
- Radiation dose and cancer risk estimates in helical CT for pulmonary tuberculosis infections
- Regular Articles
- A comparison study of steady-state vibrations with single fractional-order and distributed-order derivatives
- Regular Articles
- Some new remarks on MHD Jeffery-Hamel fluid flow problem
- Regular Articles
- Numerical investigation of magnetohydrodynamic slip flow of power-law nanofluid with temperature dependent viscosity and thermal conductivity over a permeable surface
- Regular Articles
- Charge conservation in a gravitational field in the scalar ether theory
- Regular Articles
- Measurement problem and local hidden variables with entangled photons
- Regular Articles
- Compression of hyper-spectral images using an accelerated nonnegative tensor decomposition
- Regular Articles
- Fabrication and application of coaxial polyvinyl alcohol/chitosan nanofiber membranes
- Regular Articles
- Calculating degree-based topological indices of dominating David derived networks
- Regular Articles
- The structure and conductivity of polyelectrolyte based on MEH-PPV and potassium iodide (KI) for dye-sensitized solar cells
- Regular Articles
- Chiral symmetry restoration and the critical end point in QCD
- Regular Articles
- Numerical solution for fractional Bratu’s initial value problem
- Regular Articles
- Structure and optical properties of TiO2 thin films deposited by ALD method
- Regular Articles
- Quadruple multi-wavelength conversion for access network scalability based on cross-phase modulation in an SOA-MZI
- Regular Articles
- Application of ANNs approach for wave-like and heat-like equations
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Study on node importance evaluation of the high-speed passenger traffic complex network based on the Structural Hole Theory
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A mathematical/physics model to measure the role of information and communication technology in some economies: the Chinese case
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Numerical modeling of the thermoelectric cooler with a complementary equation for heat circulation in air gaps
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- On the libration collinear points in the restricted three – body problem
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Research on Critical Nodes Algorithm in Social Complex Networks
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A simulation based research on chance constrained programming in robust facility location problem
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A mathematical/physics carbon emission reduction strategy for building supply chain network based on carbon tax policy
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Mathematical analysis of the impact mechanism of information platform on agro-product supply chain and agro-product competitiveness
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A real negative selection algorithm with evolutionary preference for anomaly detection
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A privacy-preserving parallel and homomorphic encryption scheme
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Random walk-based similarity measure method for patterns in complex object
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A Mathematical Study of Accessibility and Cohesion Degree in a High-Speed Rail Station Connected to an Urban Bus Transport Network
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Design and Simulation of the Integrated Navigation System based on Extended Kalman Filter
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Oil exploration oriented multi-sensor image fusion algorithm
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Analysis of Product Distribution Strategy in Digital Publishing Industry Based on Game-Theory
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Expanded Study on the accumulation effect of tourism under the constraint of structure
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Unstructured P2P Network Load Balance Strategy Based on Multilevel Partitioning of Hypergraph
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Research on the method of information system risk state estimation based on clustering particle filter
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Demand forecasting and information platform in tourism
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Physical-chemical properties studying of molecular structures via topological index calculating
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Local kernel nonparametric discriminant analysis for adaptive extraction of complex structures
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- City traffic flow breakdown prediction based on fuzzy rough set
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Conservation laws for a strongly damped wave equation
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Blending type approximation by Stancu-Kantorovich operators based on Pólya-Eggenberger distribution
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Computing the Ediz eccentric connectivity index of discrete dynamic structures
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A discrete epidemic model for bovine Babesiosis disease and tick populations
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Study on maintaining formations during satellite formation flying based on SDRE and LQR
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Relationship between solitary pulmonary nodule lung cancer and CT image features based on gradual clustering
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- A novel fast target tracking method for UAV aerial image
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Fuzzy comprehensive evaluation model of interuniversity collaborative learning based on network
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Conservation laws, classical symmetries and exact solutions of the generalized KdV-Burgers-Kuramoto equation
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- After notes on self-similarity exponent for fractal structures
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Excitation probability and effective temperature in the stationary regime of conductivity for Coulomb Glasses
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Comparisons of feature extraction algorithm based on unmanned aerial vehicle image
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Research on identification method of heavy vehicle rollover based on hidden Markov model
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Classifying BCI signals from novice users with extreme learning machine
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Topics on data transmission problem in software definition network
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Statistical inferences with jointly type-II censored samples from two Pareto distributions
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Estimation for coefficient of variation of an extension of the exponential distribution under type-II censoring scheme
- Special issue on Nonlinear Dynamics in General and Dynamical Systems in particular
- Analysis on trust influencing factors and trust model from multiple perspectives of online Auction
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Coupling of two-phase flow in fractured-vuggy reservoir with filling medium
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Production decline type curves analysis of a finite conductivity fractured well in coalbed methane reservoirs
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Flow Characteristic and Heat Transfer for Non-Newtonian Nanofluid in Rectangular Microchannels with Teardrop Dimples/Protrusions
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- The size prediction of potential inclusions embedded in the sub-surface of fused silica by damage morphology
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Research on carbonate reservoir interwell connectivity based on a modified diffusivity filter model
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- The method of the spatial locating of macroscopic throats based-on the inversion of dynamic interwell connectivity
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Unsteady mixed convection flow through a permeable stretching flat surface with partial slip effects through MHD nanofluid using spectral relaxation method
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- A volumetric ablation model of EPDM considering complex physicochemical process in porous structure of char layer
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Numerical simulation on ferrofluid flow in fractured porous media based on discrete-fracture model
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Macroscopic lattice Boltzmann model for heat and moisture transfer process with phase transformation in unsaturated porous media during freezing process
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Modelling of intermittent microwave convective drying: parameter sensitivity
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Simulating gas-water relative permeabilities for nanoscale porous media with interfacial effects
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Simulation of counter-current imbibition in water-wet fractured reservoirs based on discrete-fracture model
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Investigation effect of wettability and heterogeneity in water flooding and on microscopic residual oil distribution in tight sandstone cores with NMR technique
- Special Issue on Advances on Modelling of Flowing and Transport in Porous Media
- Analytical modeling of coupled flow and geomechanics for vertical fractured well in tight gas reservoirs
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Special Issue: Ever New "Loopholes" in Bell’s Argument and Experimental Tests
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- The ultimate loophole in Bell’s theorem: The inequality is identically satisfied by data sets composed of ±1′s assuming merely that they exist
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Erratum to: The ultimate loophole in Bell’s theorem: The inequality is identically satisfied by data sets composed of ±1′s assuming merely that they exist
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Rhetoric, logic, and experiment in the quantum nonlocality debate
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- What If Quantum Theory Violates All Mathematics?
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Relativity, anomalies and objectivity loophole in recent tests of local realism
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- The photon identification loophole in EPRB experiments: computer models with single-wing selection
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Bohr against Bell: complementarity versus nonlocality
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Is Einsteinian no-signalling violated in Bell tests?
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Bell’s “Theorem”: loopholes vs. conceptual flaws
- Special Issue on Ever-New "Loopholes" in Bell’s Argument and Experimental Tests
- Nonrecurrence and Bell-like inequalities
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Three-dimensional computer models of electrospinning systems
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Electric field computation and measurements in the electroporation of inhomogeneous samples
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Modelling of magnetostriction of transformer magnetic core for vibration analysis
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Comparison of the fractional power motor with cores made of various magnetic materials
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Dynamics of the line-start reluctance motor with rotor made of SMC material
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Inhomogeneous dielectrics: conformal mapping and finite-element models
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Topology optimization of induction heating model using sequential linear programming based on move limit with adaptive relaxation
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Detection of inter-turn short-circuit at start-up of induction machine based on torque analysis
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Current superimposition variable flux reluctance motor with 8 salient poles
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Modelling axial vibration in windings of power transformers
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Field analysis & eddy current losses calculation in five-phase tubular actuator
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Hybrid excited claw pole generator with skewed and non-skewed permanent magnets
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Electromagnetic phenomena analysis in brushless DC motor with speed control using PWM method
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Field-circuit analysis and measurements of a single-phase self-excited induction generator
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- A comparative analysis between classical and modified approach of description of the electrical machine windings by means of T0 method
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Field-based optimal-design of an electric motor: a new sensitivity formulation
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Application of the parametric proper generalized decomposition to the frequency-dependent calculation of the impedance of an AC line with rectangular conductors
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Virtual reality as a new trend in mechanical and electrical engineering education
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Holonomicity analysis of electromechanical systems
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- An accurate reactive power control study in virtual flux droop control
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Localized probability of improvement for kriging based multi-objective optimization
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Research of influence of open-winding faults on properties of brushless permanent magnets motor
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Optimal design of the rotor geometry of line-start permanent magnet synchronous motor using the bat algorithm
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Model of depositing layer on cylindrical surface produced by induction-assisted laser cladding process
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Detection of inter-turn faults in transformer winding using the capacitor discharge method
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- A novel hybrid genetic algorithm for optimal design of IPM machines for electric vehicle
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Lamination effects on a 3D model of the magnetic core of power transformers
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Detection of vertical disparity in three-dimensional visualizations
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Calculations of magnetic field in dynamo sheets taking into account their texture
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- 3-dimensional computer model of electrospinning multicapillary unit used for electrostatic field analysis
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Optimization of wearable microwave antenna with simplified electromagnetic model of the human body
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Induction heating process of ferromagnetic filled carbon nanotubes based on 3-D model
- Special Issue: The 18th International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering ISEF 2017
- Speed control of an induction motor by 6-switched 3-level inverter